diff --git a/applications/solvers/combustion/fireFoam/Make/options b/applications/solvers/combustion/fireFoam/Make/options
index c243c07e3d6b7cbf68de798641ddc286485b6622..93bda9792699596e15ca72a2cfbdee2262036394 100644
--- a/applications/solvers/combustion/fireFoam/Make/options
+++ b/applications/solvers/combustion/fireFoam/Make/options
@@ -49,7 +49,9 @@ EXE_LIBS = \
     -lregionModels \
     -lradiationModels \
     -lsurfaceFilmModels \
+    -lsurfaceFilmDerivedFvPatchFields \
     -lpyrolysisModels \
     -lregionCoupling \
     -llagrangianIntermediate \
+    -llagrangianTurbulence \
     -lODE
diff --git a/applications/solvers/lagrangian/DPMFoam/Allwclean b/applications/solvers/lagrangian/DPMFoam/Allwclean
new file mode 100755
index 0000000000000000000000000000000000000000..25d0b2955f150c37f4d21a8ca6718438597c6c0b
--- /dev/null
+++ b/applications/solvers/lagrangian/DPMFoam/Allwclean
@@ -0,0 +1,8 @@
+#!/bin/sh
+
+cd ${0%/*} || exit 1
+set -x
+
+wclean DPMTurbulenceModels
+wclean
+wclean MPPICFoam
diff --git a/applications/solvers/lagrangian/DPMFoam/Allwmake b/applications/solvers/lagrangian/DPMFoam/Allwmake
new file mode 100755
index 0000000000000000000000000000000000000000..6308a7052b2714af8ca552f2a7a5450d048afcba
--- /dev/null
+++ b/applications/solvers/lagrangian/DPMFoam/Allwmake
@@ -0,0 +1,8 @@
+#!/bin/sh
+
+cd ${0%/*} || exit 1
+set -x
+
+wmake DPMTurbulenceModels
+wmake
+wmake MPPICFoam
diff --git a/applications/solvers/lagrangian/DPMFoam/CourantNo.H b/applications/solvers/lagrangian/DPMFoam/CourantNo.H
new file mode 100644
index 0000000000000000000000000000000000000000..9ff53ed401aa8b758edc40046cc645a5cb668d50
--- /dev/null
+++ b/applications/solvers/lagrangian/DPMFoam/CourantNo.H
@@ -0,0 +1,51 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Global
+    CourantNo
+
+Description
+    Calculates and outputs the mean and maximum Courant Numbers.
+
+\*---------------------------------------------------------------------------*/
+
+scalar CoNum = 0.0;
+scalar meanCoNum = 0.0;
+
+if (mesh.nInternalFaces())
+{
+    scalarField sumPhi
+    (
+        fvc::surfaceSum(mag(phic))().internalField()
+    );
+
+    CoNum = 0.5*gMax(sumPhi/mesh.V().field())*runTime.deltaTValue();
+
+    meanCoNum =
+        0.5*(gSum(sumPhi)/gSum(mesh.V().field()))*runTime.deltaTValue();
+}
+
+Info<< "Courant Number mean: " << meanCoNum
+    << " max: " << CoNum << endl;
+
+// ************************************************************************* //
diff --git a/applications/solvers/lagrangian/DPMFoam/DPMFoam.C b/applications/solvers/lagrangian/DPMFoam/DPMFoam.C
new file mode 100644
index 0000000000000000000000000000000000000000..9c97968c1cbd3e14531c421119e59ad38af9cb55
--- /dev/null
+++ b/applications/solvers/lagrangian/DPMFoam/DPMFoam.C
@@ -0,0 +1,143 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Application
+    DPMFoam
+
+Description
+    Transient solver for the coupled transport of a single kinematic particle
+    could including the effect of the volume fraction of particles on the
+    continuous phase.
+
+\*---------------------------------------------------------------------------*/
+
+#include "fvCFD.H"
+#include "singlePhaseTransportModel.H"
+#include "PhaseIncompressibleTurbulenceModel.H"
+#include "pimpleControl.H"
+#include "fixedFluxPressureFvPatchScalarField.H"
+
+#ifdef MPPIC
+    #include "basicKinematicMPPICCloud.H"
+    #define basicKinematicTypeCloud basicKinematicMPPICCloud
+#else
+    #include "basicKinematicCollidingCloud.H"
+    #define basicKinematicTypeCloud basicKinematicCollidingCloud
+#endif
+
+int main(int argc, char *argv[])
+{
+    argList::addOption
+    (
+        "cloudName",
+        "name",
+        "specify alternative cloud name. default is 'kinematicCloud'"
+    );
+
+    #include "setRootCase.H"
+    #include "createTime.H"
+    #include "createMesh.H"
+    #include "readGravitationalAcceleration.H"
+    #include "createFields.H"
+    #include "initContinuityErrs.H"
+
+    pimpleControl pimple(mesh);
+
+    Info<< "\nStarting time loop\n" << endl;
+
+    while (runTime.run())
+    {
+        #include "readTimeControls.H"
+        #include "CourantNo.H"
+        #include "setDeltaT.H"
+
+        runTime++;
+
+        Info<< "Time = " << runTime.timeName() << nl << endl;
+
+        continuousPhaseTransport.correct();
+        muc = rhoc*continuousPhaseTransport.nu();
+
+        Info<< "Evolving " << kinematicCloud.name() << endl;
+        kinematicCloud.evolve();
+
+        // Update continuous phase volume fraction field
+        alphac = max(1.0 - kinematicCloud.theta(), alphacMin);
+        alphac.correctBoundaryConditions();
+        alphacf = fvc::interpolate(alphac);
+        alphaPhic = alphacf*phic;
+
+        fvVectorMatrix cloudSU(kinematicCloud.SU(Uc));
+        volVectorField cloudVolSUSu
+        (
+            IOobject
+            (
+                "cloudVolSUSu",
+                runTime.timeName(),
+                mesh
+            ),
+            mesh,
+            dimensionedVector
+            (
+                "0",
+                cloudSU.dimensions()/dimVolume,
+                vector::zero
+            ),
+            zeroGradientFvPatchVectorField::typeName
+        );
+
+        cloudVolSUSu.internalField() = - cloudSU.source()/mesh.V();
+        cloudVolSUSu.correctBoundaryConditions();
+        cloudSU.source() = vector::zero;
+
+        // --- Pressure-velocity PIMPLE corrector loop
+        while (pimple.loop())
+        {
+            #include "UcEqn.H"
+
+            // --- PISO loop
+            while (pimple.correct())
+            {
+                #include "pEqn.H"
+            }
+
+            if (pimple.turbCorr())
+            {
+                continuousPhaseTurbulence->correct();
+            }
+        }
+
+        runTime.write();
+
+        Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s"
+            << "  ClockTime = " << runTime.elapsedClockTime() << " s"
+            << nl << endl;
+    }
+
+    Info<< "End\n" << endl;
+
+    return 0;
+}
+
+
+// ************************************************************************* //
diff --git a/applications/solvers/lagrangian/DPMFoam/DPMTurbulenceModels/DPMTurbulenceModels.C b/applications/solvers/lagrangian/DPMFoam/DPMTurbulenceModels/DPMTurbulenceModels.C
new file mode 100644
index 0000000000000000000000000000000000000000..1aeca779573b243add17fabb301afbea523f4353
--- /dev/null
+++ b/applications/solvers/lagrangian/DPMFoam/DPMTurbulenceModels/DPMTurbulenceModels.C
@@ -0,0 +1,61 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "PhaseIncompressibleTurbulenceModel.H"
+#include "singlePhaseTransportModel.H"
+#include "addToRunTimeSelectionTable.H"
+#include "makeTurbulenceModel.H"
+
+#include "laminar.H"
+#include "RASModel.H"
+#include "LESModel.H"
+
+makeBaseTurbulenceModel
+(
+    volScalarField,
+    geometricOneField,
+    incompressibleTurbulenceModel,
+    PhaseIncompressibleTurbulenceModel,
+    singlePhaseTransportModel
+);
+
+#define makeRASModel(Type)                                                     \
+    makeTemplatedTurbulenceModel                                               \
+    (singlePhaseTransportModelPhaseIncompressibleTurbulenceModel, RAS, Type)
+
+#define makeLESModel(Type)                                                     \
+    makeTemplatedTurbulenceModel                                               \
+    (singlePhaseTransportModelPhaseIncompressibleTurbulenceModel, LES, Type)
+
+#include "kEpsilon.H"
+makeRASModel(kEpsilon);
+
+#include "Smagorinsky.H"
+makeLESModel(Smagorinsky);
+
+#include "kEqn.H"
+makeLESModel(kEqn);
+
+// ************************************************************************* //
diff --git a/applications/solvers/lagrangian/DPMFoam/DPMTurbulenceModels/Make/files b/applications/solvers/lagrangian/DPMFoam/DPMTurbulenceModels/Make/files
new file mode 100644
index 0000000000000000000000000000000000000000..3b6b48c2c47dd2a53a3b2c6e4e4ed44c9ef43aee
--- /dev/null
+++ b/applications/solvers/lagrangian/DPMFoam/DPMTurbulenceModels/Make/files
@@ -0,0 +1,3 @@
+DPMTurbulenceModels.C
+
+LIB = $(FOAM_LIBBIN)/libDPMTurbulenceModels
diff --git a/applications/solvers/lagrangian/DPMFoam/DPMTurbulenceModels/Make/options b/applications/solvers/lagrangian/DPMFoam/DPMTurbulenceModels/Make/options
new file mode 100644
index 0000000000000000000000000000000000000000..716929b5620b3b554172cea22257a6e4580294d3
--- /dev/null
+++ b/applications/solvers/lagrangian/DPMFoam/DPMTurbulenceModels/Make/options
@@ -0,0 +1,9 @@
+EXE_INC = \
+    -I$(LIB_SRC)/foam/lnInclude \
+    -I$(LIB_SRC)/finiteVolume/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \
+    -I$(LIB_SRC)/transportModels \
+    -I$(LIB_SRC)/transportModels/incompressible/singlePhaseTransportModel \
+    -I$(LIB_SRC)/TurbulenceModels/turbulenceModels/lnInclude \
+    -I$(LIB_SRC)/TurbulenceModels/incompressible/lnInclude \
+    -I$(LIB_SRC)/TurbulenceModels/phaseIncompressible/lnInclude
diff --git a/applications/solvers/lagrangian/DPMFoam/MPPICFoam/MPPICFoam.C b/applications/solvers/lagrangian/DPMFoam/MPPICFoam/MPPICFoam.C
new file mode 100644
index 0000000000000000000000000000000000000000..5a036f8f508acb2b5d3d2b5f190606d631c759cd
--- /dev/null
+++ b/applications/solvers/lagrangian/DPMFoam/MPPICFoam/MPPICFoam.C
@@ -0,0 +1,40 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Application
+    MPPICFoam
+
+Description
+    Transient solver for the coupled transport of a single kinematic particle
+    could including the effect of the volume fraction of particles on the
+    continuous phase. Multi-Phase Particle In Cell (MPPIC) modeling is used to
+    represent collisions without resolving particle-particle interactions.
+
+\*---------------------------------------------------------------------------*/
+
+#define MPPIC
+
+#include "DPMFoam.C"
+
+
+// ************************************************************************* //
diff --git a/applications/solvers/lagrangian/DPMFoam/MPPICFoam/Make/files b/applications/solvers/lagrangian/DPMFoam/MPPICFoam/Make/files
new file mode 100644
index 0000000000000000000000000000000000000000..d311f5a33c82b9531db9b71637927883e9c09bc3
--- /dev/null
+++ b/applications/solvers/lagrangian/DPMFoam/MPPICFoam/Make/files
@@ -0,0 +1,3 @@
+MPPICFoam.C
+
+EXE = $(FOAM_APPBIN)/MPPICFoam
diff --git a/applications/solvers/lagrangian/DPMFoam/MPPICFoam/Make/options b/applications/solvers/lagrangian/DPMFoam/MPPICFoam/Make/options
new file mode 100644
index 0000000000000000000000000000000000000000..948df098388eb10bab7d02e4449302a8c05f569d
--- /dev/null
+++ b/applications/solvers/lagrangian/DPMFoam/MPPICFoam/Make/options
@@ -0,0 +1,34 @@
+EXE_INC = \
+    -I.. \
+    -I../DPMTurbulenceModels/lnInclude \
+    -I$(LIB_SRC)/finiteVolume/lnInclude \
+    -I$(LIB_SRC)/meshTools/lnInclude \
+    -I$(LIB_SRC)/lagrangian/basic/lnInclude \
+    -I$(LIB_SRC)/lagrangian/intermediate/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/specie/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/reactionThermo/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/radiation/lnInclude \
+    -I$(LIB_SRC)/transportModels \
+    -I$(LIB_SRC)/transportModels/incompressible/singlePhaseTransportModel \
+    -I$(LIB_SRC)/TurbulenceModels/turbulenceModels/lnInclude \
+    -I$(LIB_SRC)/TurbulenceModels/incompressible/lnInclude \
+    -I$(LIB_SRC)/TurbulenceModels/phaseIncompressible/lnInclude \
+    -I$(LIB_SRC)/regionModels/regionModel/lnInclude \
+    -I$(LIB_SRC)/regionModels/surfaceFilmModels/lnInclude \
+
+EXE_LIBS = \
+    -lfiniteVolume \
+    -lmeshTools \
+    -llagrangian \
+    -llagrangianIntermediate \
+    -lthermophysicalFunctions \
+    -lspecie \
+    -lradiationModels \
+    -lincompressibleTransportModels \
+    -lturbulenceModels \
+    -lincompressibleTurbulenceModels \
+    -lDPMTurbulenceModels \
+    -lregionModels \
+    -lsurfaceFilmModels \
+    -lsampling
diff --git a/applications/solvers/lagrangian/DPMFoam/Make/files b/applications/solvers/lagrangian/DPMFoam/Make/files
new file mode 100644
index 0000000000000000000000000000000000000000..c4d729205dc442480ed377f8f130a37d45382636
--- /dev/null
+++ b/applications/solvers/lagrangian/DPMFoam/Make/files
@@ -0,0 +1,3 @@
+DPMFoam.C
+
+EXE = $(FOAM_APPBIN)/DPMFoam
diff --git a/applications/solvers/lagrangian/DPMFoam/Make/options b/applications/solvers/lagrangian/DPMFoam/Make/options
new file mode 100644
index 0000000000000000000000000000000000000000..e9524dfc2beafae2ccb910c7904a6474a9e7416e
--- /dev/null
+++ b/applications/solvers/lagrangian/DPMFoam/Make/options
@@ -0,0 +1,33 @@
+EXE_INC = \
+    -I./DPMTurbulenceModels/lnInclude \
+    -I$(LIB_SRC)/finiteVolume/lnInclude \
+    -I$(LIB_SRC)/meshTools/lnInclude \
+    -I$(LIB_SRC)/lagrangian/basic/lnInclude \
+    -I$(LIB_SRC)/lagrangian/intermediate/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/specie/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/reactionThermo/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/radiation/lnInclude \
+    -I$(LIB_SRC)/transportModels \
+    -I$(LIB_SRC)/transportModels/incompressible/singlePhaseTransportModel \
+    -I$(LIB_SRC)/TurbulenceModels/turbulenceModels/lnInclude \
+    -I$(LIB_SRC)/TurbulenceModels/incompressible/lnInclude \
+    -I$(LIB_SRC)/TurbulenceModels/phaseIncompressible/lnInclude \
+    -I$(LIB_SRC)/regionModels/regionModel/lnInclude \
+    -I$(LIB_SRC)/regionModels/surfaceFilmModels/lnInclude
+
+EXE_LIBS = \
+    -lfiniteVolume \
+    -lmeshTools \
+    -llagrangian \
+    -llagrangianIntermediate \
+    -lthermophysicalFunctions \
+    -lspecie \
+    -lradiationModels \
+    -lincompressibleTransportModels \
+    -lturbulenceModels \
+    -lincompressibleTurbulenceModels \
+    -lDPMTurbulenceModels \
+    -lregionModels \
+    -lsurfaceFilmModels \
+    -lsampling
diff --git a/applications/solvers/lagrangian/DPMFoam/UcEqn.H b/applications/solvers/lagrangian/DPMFoam/UcEqn.H
new file mode 100644
index 0000000000000000000000000000000000000000..0bd4a7146d491806f94ddab676670bf331d835ba
--- /dev/null
+++ b/applications/solvers/lagrangian/DPMFoam/UcEqn.H
@@ -0,0 +1,32 @@
+fvVectorMatrix UcEqn
+(
+    fvm::ddt(alphac, Uc) + fvm::div(alphaPhic, Uc)
+  - fvm::Sp(fvc::ddt(alphac) + fvc::div(alphaPhic), Uc)
+  + continuousPhaseTurbulence->divDevRhoReff(Uc)
+ ==
+    (1.0/rhoc)*cloudSU
+);
+
+UcEqn.relax();
+
+volScalarField rAUc(1.0/UcEqn.A());
+surfaceScalarField rAUcf("Dp", fvc::interpolate(rAUc));
+
+surfaceScalarField phicForces
+(
+   (fvc::interpolate(rAUc*cloudVolSUSu/rhoc) & mesh.Sf())
+ + rAUcf*(g & mesh.Sf())
+);
+
+if (pimple.momentumPredictor())
+{
+    solve
+    (
+        UcEqn
+     ==
+        fvc::reconstruct
+        (
+            phicForces/rAUcf - fvc::snGrad(p)*mesh.magSf()
+        )
+    );
+}
diff --git a/applications/solvers/lagrangian/DPMFoam/continuityErrs.H b/applications/solvers/lagrangian/DPMFoam/continuityErrs.H
new file mode 100644
index 0000000000000000000000000000000000000000..f07d42b39a6473fc92d34c7ee3354e9e198ca9ee
--- /dev/null
+++ b/applications/solvers/lagrangian/DPMFoam/continuityErrs.H
@@ -0,0 +1,48 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Global
+    continuityErrs
+
+Description
+    Calculates and prints the continuity errors.
+
+\*---------------------------------------------------------------------------*/
+
+{
+    volScalarField contErr(fvc::ddt(alphac) + fvc::div(alphacf*phic));
+
+    scalar sumLocalContErr = runTime.deltaTValue()*
+        mag(contErr)().weightedAverage(mesh.V()).value();
+
+    scalar globalContErr = runTime.deltaTValue()*
+        contErr.weightedAverage(mesh.V()).value();
+    cumulativeContErr += globalContErr;
+
+    Info<< "time step continuity errors : sum local = " << sumLocalContErr
+        << ", global = " << globalContErr
+        << ", cumulative = " << cumulativeContErr
+        << endl;
+}
+
+// ************************************************************************* //
diff --git a/applications/solvers/lagrangian/DPMFoam/createFields.H b/applications/solvers/lagrangian/DPMFoam/createFields.H
new file mode 100644
index 0000000000000000000000000000000000000000..16ed9fa9192f390ab9b8a5f68690f43aa10855a7
--- /dev/null
+++ b/applications/solvers/lagrangian/DPMFoam/createFields.H
@@ -0,0 +1,166 @@
+    Info<< "\nReading transportProperties\n" << endl;
+
+    IOdictionary transportProperties
+    (
+        IOobject
+        (
+            "transportProperties",
+            runTime.constant(),
+            mesh,
+            IOobject::MUST_READ_IF_MODIFIED,
+            IOobject::NO_WRITE
+        )
+    );
+
+    word contiuousPhaseName(transportProperties.lookup("contiuousPhaseName"));
+
+    dimensionedScalar rhocValue
+    (
+        IOobject::groupName("rho", contiuousPhaseName),
+        dimDensity,
+        transportProperties.lookup
+        (
+            IOobject::groupName("rho", contiuousPhaseName)
+        )
+    );
+
+    volScalarField rhoc
+    (
+        IOobject
+        (
+            rhocValue.name(),
+            runTime.timeName(),
+            mesh,
+            IOobject::NO_READ,
+            IOobject::AUTO_WRITE
+        ),
+        mesh,
+        rhocValue
+    );
+
+    Info<< "Reading field U\n" << endl;
+    volVectorField Uc
+    (
+        IOobject
+        (
+            IOobject::groupName("U", contiuousPhaseName),
+            runTime.timeName(),
+            mesh,
+            IOobject::MUST_READ,
+            IOobject::AUTO_WRITE
+        ),
+        mesh
+    );
+
+    Info<< "Reading field p\n" << endl;
+    volScalarField p
+    (
+        IOobject
+        (
+            "p",
+            runTime.timeName(),
+            mesh,
+            IOobject::MUST_READ,
+            IOobject::AUTO_WRITE
+        ),
+        mesh
+    );
+
+
+    Info<< "Reading/calculating continuous-phase face flux field phic\n"
+        << endl;
+
+    surfaceScalarField phic
+    (
+        IOobject
+        (
+            IOobject::groupName("phi", contiuousPhaseName),
+            runTime.timeName(),
+            mesh,
+            IOobject::READ_IF_PRESENT,
+            IOobject::AUTO_WRITE
+        ),
+        linearInterpolate(Uc) & mesh.Sf()
+    );
+
+    label pRefCell = 0;
+    scalar pRefValue = 0.0;
+    setRefCell(p, mesh.solutionDict().subDict("PIMPLE"), pRefCell, pRefValue);
+
+    Info<< "Creating turbulence model\n" << endl;
+
+    singlePhaseTransportModel continuousPhaseTransport(Uc, phic);
+
+    volScalarField muc
+    (
+        IOobject
+        (
+            IOobject::groupName("mu", contiuousPhaseName),
+            runTime.timeName(),
+            mesh,
+            IOobject::NO_READ,
+            IOobject::AUTO_WRITE
+        ),
+        rhoc*continuousPhaseTransport.nu()
+    );
+
+    Info << "Creating field alphac\n" << endl;
+    // alphac must be constructed before the cloud
+    // so that the drag-models can find it
+    volScalarField alphac
+    (
+        IOobject
+        (
+            IOobject::groupName("alpha", contiuousPhaseName),
+            runTime.timeName(),
+            mesh,
+            IOobject::READ_IF_PRESENT,
+            IOobject::AUTO_WRITE
+        ),
+        mesh,
+        dimensionedScalar("0", dimless, 0)
+    );
+
+    word kinematicCloudName("kinematicCloud");
+    args.optionReadIfPresent("cloudName", kinematicCloudName);
+
+    Info<< "Constructing kinematicCloud " << kinematicCloudName << endl;
+    basicKinematicTypeCloud kinematicCloud
+    (
+        kinematicCloudName,
+        rhoc,
+        Uc,
+        muc,
+        g
+    );
+
+    // Particle fraction upper limit
+    scalar alphacMin
+    (
+        1.0
+      - readScalar
+        (
+            kinematicCloud.particleProperties().subDict("constantProperties")
+           .lookup("alphaMax")
+        )
+    );
+
+    // Update alphac from the particle locations
+    alphac = max(1.0 - kinematicCloud.theta(), alphacMin);
+    alphac.correctBoundaryConditions();
+
+    surfaceScalarField alphacf("alphacf", fvc::interpolate(alphac));
+    surfaceScalarField alphaPhic("alphaPhic", alphacf*phic);
+
+    autoPtr<PhaseIncompressibleTurbulenceModel<singlePhaseTransportModel> >
+    continuousPhaseTurbulence
+    (
+        PhaseIncompressibleTurbulenceModel<singlePhaseTransportModel>::New
+        (
+            alphac,
+            Uc,
+            alphaPhic,
+            phic,
+            continuousPhaseTransport
+        )
+    );
diff --git a/applications/solvers/lagrangian/DPMFoam/pEqn.H b/applications/solvers/lagrangian/DPMFoam/pEqn.H
new file mode 100644
index 0000000000000000000000000000000000000000..34cce4f1668425107a0404c66f6c85a4a671791c
--- /dev/null
+++ b/applications/solvers/lagrangian/DPMFoam/pEqn.H
@@ -0,0 +1,52 @@
+{
+    volVectorField HbyA("HbyA", Uc);
+    HbyA = rAUc*UcEqn.H();
+
+    surfaceScalarField phiHbyA
+    (
+        "phiHbyA",
+        (
+           (fvc::interpolate(HbyA) & mesh.Sf())
+         + alphacf*rAUcf*fvc::ddtCorr(Uc, phic)
+         + phicForces
+        )
+    );
+
+    // Update the fixedFluxPressure BCs to ensure flux consistency
+    setSnGrad<fixedFluxPressureFvPatchScalarField>
+    (
+        p.boundaryField(),
+        (
+            phiHbyA.boundaryField()
+            - (mesh.Sf().boundaryField() & Uc.boundaryField())
+        )/(mesh.magSf().boundaryField()*rAUcf.boundaryField())
+    );
+
+    // Non-orthogonal pressure corrector loop
+    while (pimple.correctNonOrthogonal())
+    {
+        fvScalarMatrix pEqn
+        (
+            fvm::laplacian(alphacf*rAUcf, p)
+         ==
+            fvc::ddt(alphac) + fvc::div(alphacf*phiHbyA)
+        );
+
+        pEqn.setReference(pRefCell, pRefValue);
+
+        pEqn.solve(mesh.solver(p.select(pimple.finalInnerIter())));
+
+        if (pimple.finalNonOrthogonalIter())
+        {
+            phic = phiHbyA - pEqn.flux()/alphacf;
+
+            p.relax();
+
+            Uc = HbyA
+              + rAUc*fvc::reconstruct((phicForces - pEqn.flux()/alphacf)/rAUcf);
+            Uc.correctBoundaryConditions();
+        }
+    }
+}
+
+#include "continuityErrs.H"
diff --git a/applications/solvers/lagrangian/coalChemistryFoam/Make/options b/applications/solvers/lagrangian/coalChemistryFoam/Make/options
index 85cd3a4713a8745ba72b995f0262f66a7e9288c4..4f85279a69770a1fc2495d0417c6ead246950a99 100644
--- a/applications/solvers/lagrangian/coalChemistryFoam/Make/options
+++ b/applications/solvers/lagrangian/coalChemistryFoam/Make/options
@@ -35,6 +35,7 @@ EXE_LIBS = \
     -lcompressibleLESModels \
     -llagrangian \
     -llagrangianIntermediate \
+    -llagrangianTurbulence \
     -lcoalCombustion\
     -lspecie \
     -lfluidThermophysicalModels \
diff --git a/applications/solvers/lagrangian/icoUncoupledKinematicParcelFoam/Make/options b/applications/solvers/lagrangian/icoUncoupledKinematicParcelFoam/Make/options
index cb0f90524a56003c87aa192cba3889fca575eac3..13f3b20206ec58b51fd4163b80ced2413dd8f420 100644
--- a/applications/solvers/lagrangian/icoUncoupledKinematicParcelFoam/Make/options
+++ b/applications/solvers/lagrangian/icoUncoupledKinematicParcelFoam/Make/options
@@ -16,6 +16,7 @@ EXE_INC = \
 EXE_LIBS = \
     -llagrangian \
     -llagrangianIntermediate \
+    -llagrangianTurbulence \
     -lthermophysicalFunctions \
     -lfluidThermophysicalModels \
     -lspecie \
diff --git a/applications/solvers/lagrangian/icoUncoupledKinematicParcelFoam/icoUncoupledKinematicParcelDyMFoam/Make/options b/applications/solvers/lagrangian/icoUncoupledKinematicParcelFoam/icoUncoupledKinematicParcelDyMFoam/Make/options
index 942c217fa48310294f823887ffaab0db0460a303..2474917002178e43a5c8c18332c7be5e28918a92 100644
--- a/applications/solvers/lagrangian/icoUncoupledKinematicParcelFoam/icoUncoupledKinematicParcelDyMFoam/Make/options
+++ b/applications/solvers/lagrangian/icoUncoupledKinematicParcelFoam/icoUncoupledKinematicParcelDyMFoam/Make/options
@@ -20,6 +20,7 @@ EXE_INC = \
 EXE_LIBS = \
     -llagrangian \
     -llagrangianIntermediate \
+    -llagrangianTurbulence \
     -lthermophysicalFunctions \
     -lfluidThermophysicalModels \
     -lspecie \
diff --git a/applications/solvers/lagrangian/reactingParcelFilmFoam/Make/options b/applications/solvers/lagrangian/reactingParcelFilmFoam/Make/options
index e0aac8c5dbb8e4011de1fb0da9e8a2b1348d7978..1520f13fcb7a8af1600dce7e55c0f22628db5255 100644
--- a/applications/solvers/lagrangian/reactingParcelFilmFoam/Make/options
+++ b/applications/solvers/lagrangian/reactingParcelFilmFoam/Make/options
@@ -43,6 +43,8 @@ EXE_LIBS = \
     -lregionModels \
     -lradiationModels \
     -lsurfaceFilmModels \
+    -lsurfaceFilmDerivedFvPatchFields \
     -llagrangianIntermediate \
+    -llagrangianTurbulence \
     -lODE \
     -lcombustionModels
diff --git a/applications/solvers/lagrangian/reactingParcelFoam/LTSReactingParcelFoam/Make/options b/applications/solvers/lagrangian/reactingParcelFoam/LTSReactingParcelFoam/Make/options
index 9aa1847960966e57ec60a341e92fded3ef701f49..2cc7dfa1e7825fea2774eb3bf5893e03acd3a6e3 100644
--- a/applications/solvers/lagrangian/reactingParcelFoam/LTSReactingParcelFoam/Make/options
+++ b/applications/solvers/lagrangian/reactingParcelFoam/LTSReactingParcelFoam/Make/options
@@ -34,6 +34,7 @@ EXE_LIBS = \
     -lcompressibleLESModels \
     -llagrangian \
     -llagrangianIntermediate \
+    -llagrangianTurbulence \
     -lspecie \
     -lfluidThermophysicalModels \
     -lliquidProperties \
diff --git a/applications/solvers/lagrangian/reactingParcelFoam/Make/options b/applications/solvers/lagrangian/reactingParcelFoam/Make/options
index 705cfc9433f4f9e47764f0f7d26e59cb0d82ff2c..ce479be6b6c14779f6e72986b69db511db3299e4 100644
--- a/applications/solvers/lagrangian/reactingParcelFoam/Make/options
+++ b/applications/solvers/lagrangian/reactingParcelFoam/Make/options
@@ -34,6 +34,7 @@ EXE_LIBS = \
     -lcompressibleLESModels \
     -llagrangian \
     -llagrangianIntermediate \
+    -llagrangianTurbulence \
     -lspecie \
     -lfluidThermophysicalModels \
     -lliquidProperties \
diff --git a/applications/solvers/lagrangian/reactingParcelFoam/simpleReactingParcelFoam/Make/options b/applications/solvers/lagrangian/reactingParcelFoam/simpleReactingParcelFoam/Make/options
index 705cfc9433f4f9e47764f0f7d26e59cb0d82ff2c..ce479be6b6c14779f6e72986b69db511db3299e4 100644
--- a/applications/solvers/lagrangian/reactingParcelFoam/simpleReactingParcelFoam/Make/options
+++ b/applications/solvers/lagrangian/reactingParcelFoam/simpleReactingParcelFoam/Make/options
@@ -34,6 +34,7 @@ EXE_LIBS = \
     -lcompressibleLESModels \
     -llagrangian \
     -llagrangianIntermediate \
+    -llagrangianTurbulence \
     -lspecie \
     -lfluidThermophysicalModels \
     -lliquidProperties \
diff --git a/applications/solvers/lagrangian/sprayFoam/Make/options b/applications/solvers/lagrangian/sprayFoam/Make/options
index 9dce65d02351332ef2934207d713b6636640e8a8..bbae7d499bf96de56e71f83682e4a55d9aa9256f 100644
--- a/applications/solvers/lagrangian/sprayFoam/Make/options
+++ b/applications/solvers/lagrangian/sprayFoam/Make/options
@@ -35,6 +35,7 @@ EXE_LIBS = \
     -lcompressibleLESModels \
     -llagrangian \
     -llagrangianIntermediate \
+    -llagrangianTurbulence \
     -llagrangianSpray \
     -lspecie \
     -lfluidThermophysicalModels \
diff --git a/applications/solvers/lagrangian/sprayFoam/sprayEngineFoam/Make/options b/applications/solvers/lagrangian/sprayFoam/sprayEngineFoam/Make/options
index 77034c9ef3b992e83ba612a970b62f32e0ba8b32..e516ea3f108fadc78c20e08047a09fa19717d0b4 100644
--- a/applications/solvers/lagrangian/sprayFoam/sprayEngineFoam/Make/options
+++ b/applications/solvers/lagrangian/sprayFoam/sprayEngineFoam/Make/options
@@ -37,6 +37,7 @@ EXE_LIBS = \
     -lcompressibleLESModels \
     -llagrangian \
     -llagrangianIntermediate \
+    -llagrangianTurbulence \
     -llagrangianSpray \
     -lspecie \
     -lfluidThermophysicalModels \
diff --git a/applications/solvers/lagrangian/uncoupledKinematicParcelFoam/Make/options b/applications/solvers/lagrangian/uncoupledKinematicParcelFoam/Make/options
index 12c7c1c551124077ff728b972778e9c0a303b38c..dd86faf2ab293fd8fba46396d4aadb2f52380d59 100644
--- a/applications/solvers/lagrangian/uncoupledKinematicParcelFoam/Make/options
+++ b/applications/solvers/lagrangian/uncoupledKinematicParcelFoam/Make/options
@@ -14,6 +14,7 @@ EXE_INC = \
 EXE_LIBS = \
     -llagrangian \
     -llagrangianIntermediate \
+    -llagrangianTurbulence \
     -lthermophysicalFunctions \
     -lfluidThermophysicalModels \
     -lspecie \
diff --git a/applications/solvers/multiphase/compressibleInterFoam/compressibleInterDyMFoam/pEqn.H b/applications/solvers/multiphase/compressibleInterFoam/compressibleInterDyMFoam/pEqn.H
index a014a5ab4edcc2ca517b2552ed655bca42297b6c..e7fd7241db93d9e82c1c2c06a289c8afda7d6c30 100644
--- a/applications/solvers/multiphase/compressibleInterFoam/compressibleInterDyMFoam/pEqn.H
+++ b/applications/solvers/multiphase/compressibleInterFoam/compressibleInterDyMFoam/pEqn.H
@@ -32,6 +32,9 @@
         )/(mesh.magSf().boundaryField()*rAUf.boundaryField())
     );
 
+    // Make the fluxes relative to the mesh motion
+    fvc::makeRelative(phiHbyA, U);
+
     tmp<fvScalarMatrix> p_rghEqnComp1;
     tmp<fvScalarMatrix> p_rghEqnComp2;
 
@@ -114,12 +117,9 @@
     {
         Uf = fvc::interpolate(U);
         surfaceVectorField n(mesh.Sf()/mesh.magSf());
-        Uf += n*(phi/mesh.magSf() - (n & Uf));
+        Uf += n*(fvc::absolute(phi, U)/mesh.magSf() - (n & Uf));
     }
 
-    // Make the fluxes relative to the mesh motion
-    fvc::makeRelative(phi, U);
-
     // Update densities from change in p_rgh
     rho1 += psi1*(p_rgh - p_rgh_0);
     rho2 += psi2*(p_rgh - p_rgh_0);
diff --git a/applications/solvers/multiphase/interFoam/interDyMFoam/correctPhi.H b/applications/solvers/multiphase/interFoam/interDyMFoam/correctPhi.H
index 53d04d827f1975ab033efb99498a06f267875f97..699d789adb150fa16005d5215d36d5a5294d3196 100644
--- a/applications/solvers/multiphase/interFoam/interDyMFoam/correctPhi.H
+++ b/applications/solvers/multiphase/interFoam/interDyMFoam/correctPhi.H
@@ -37,7 +37,8 @@ if (mesh.changing())
         pcorrTypes
     );
 
-    dimensionedScalar rAUf("rAUf", dimTime/rho.dimensions(), 1.0);
+    // dimensionedScalar rAUf("rAUf", dimTime/rho.dimensions(), 1.0);
+    surfaceScalarField rAUf("rAUf", fvc::interpolate(rAU));
 
     while (pimple.correctNonOrthogonal())
     {
diff --git a/applications/solvers/multiphase/interFoam/interDyMFoam/interDyMFoam.C b/applications/solvers/multiphase/interFoam/interDyMFoam/interDyMFoam.C
index ba7b4efa9ae1094b0e14f3c5a43d7a76868a3102..83398509e7846f971a1e59cdd4790bcce76f957a 100644
--- a/applications/solvers/multiphase/interFoam/interDyMFoam/interDyMFoam.C
+++ b/applications/solvers/multiphase/interFoam/interDyMFoam/interDyMFoam.C
@@ -57,6 +57,21 @@ int main(int argc, char *argv[])
     #include "createFields.H"
     #include "readTimeControls.H"
     #include "createPrghCorrTypes.H"
+
+    volScalarField rAU
+    (
+        IOobject
+        (
+            "rAU",
+            runTime.timeName(),
+            mesh,
+            IOobject::READ_IF_PRESENT,
+            IOobject::AUTO_WRITE
+        ),
+        mesh,
+        dimensionedScalar("rAUf", dimTime/rho.dimensions(), 1.0)
+    );
+
     #include "correctPhi.H"
     #include "createUf.H"
     #include "CourantNo.H"
diff --git a/applications/solvers/multiphase/interFoam/interDyMFoam/pEqn.H b/applications/solvers/multiphase/interFoam/interDyMFoam/pEqn.H
index 76441207919fe4427f6734750ff4de1a26c544f4..ec99a6388388b68f7ca55eccafdbc096e04d5f6c 100644
--- a/applications/solvers/multiphase/interFoam/interDyMFoam/pEqn.H
+++ b/applications/solvers/multiphase/interFoam/interDyMFoam/pEqn.H
@@ -1,5 +1,5 @@
 {
-    volScalarField rAU("rAU", 1.0/UEqn.A());
+    rAU = 1.0/UEqn.A();
     surfaceScalarField rAUf("rAUf", fvc::interpolate(rAU));
 
     volVectorField HbyA("HbyA", U);
diff --git a/applications/solvers/multiphase/interPhaseChangeFoam/interPhaseChangeDyMFoam/interPhaseChangeDyMFoam.C b/applications/solvers/multiphase/interPhaseChangeFoam/interPhaseChangeDyMFoam/interPhaseChangeDyMFoam.C
index 810edeff308fb8ee57549e504f71aeb2a53b7ac4..8bd1984539762e9318216f2063c05645486a5a52 100644
--- a/applications/solvers/multiphase/interPhaseChangeFoam/interPhaseChangeDyMFoam/interPhaseChangeDyMFoam.C
+++ b/applications/solvers/multiphase/interPhaseChangeFoam/interPhaseChangeDyMFoam/interPhaseChangeDyMFoam.C
@@ -67,6 +67,21 @@ int main(int argc, char *argv[])
     #include "createFields.H"
     #include "readTimeControls.H"
     #include "createPcorrTypes.H"
+
+    volScalarField rAU
+    (
+        IOobject
+        (
+            "rAU",
+            runTime.timeName(),
+            mesh,
+            IOobject::READ_IF_PRESENT,
+            IOobject::AUTO_WRITE
+        ),
+        mesh,
+        dimensionedScalar("rAUf", dimTime/rho.dimensions(), 1.0)
+    );
+
     #include "../interFoam/interDyMFoam/correctPhi.H"
     #include "createUf.H"
     #include "CourantNo.H"
diff --git a/applications/solvers/multiphase/interPhaseChangeFoam/interPhaseChangeDyMFoam/pEqn.H b/applications/solvers/multiphase/interPhaseChangeFoam/interPhaseChangeDyMFoam/pEqn.H
index 6fac1df95c2236b94da9914f01a8de5416ed230f..5915b6803596f256e36c119b1a27d9a8c968d785 100644
--- a/applications/solvers/multiphase/interPhaseChangeFoam/interPhaseChangeDyMFoam/pEqn.H
+++ b/applications/solvers/multiphase/interPhaseChangeFoam/interPhaseChangeDyMFoam/pEqn.H
@@ -1,5 +1,5 @@
 {
-    volScalarField rAU("rAU", 1.0/UEqn.A());
+    rAU = 1.0/UEqn.A();
     surfaceScalarField rAUf("rAUf", fvc::interpolate(rAU));
 
     volVectorField HbyA("HbyA", U);
diff --git a/applications/utilities/mesh/generation/snappyHexMesh/snappyHexMeshDict b/applications/utilities/mesh/generation/snappyHexMesh/snappyHexMeshDict
index 87922d974d8a5062b70cba93f757b8c7a1013f3b..44cdbaeec6d46a17498bf53bdd462da16e2ce274 100644
--- a/applications/utilities/mesh/generation/snappyHexMesh/snappyHexMeshDict
+++ b/applications/utilities/mesh/generation/snappyHexMesh/snappyHexMeshDict
@@ -410,12 +410,17 @@ addLayersControls
         // Number of smoothing iterations of interior mesh movement direction
         nSmoothNormals 3;
 
+        // Optional: limit the number of steps walking away from the surface.
+        // Default is unlimited.
+        //nMedialAxisIter 10;
+
         // Optional: smooth displacement after medial axis determination.
         // default is 0.
-        nSmoothDisplacement 90;
+        //nSmoothDisplacement 90;
 
-        // Optional: limit the number of steps walking away from the surface
-        nMedialAxisIter 10;
+        // Optional: do not extrude any point where all surrounding faces
+        // have at least one point not extruded. Default is true.
+        //detectExtrusionIsland false;
 
 
     // Mesh shrinking
diff --git a/applications/utilities/parallelProcessing/reconstructPar/reconstructPar.C b/applications/utilities/parallelProcessing/reconstructPar/reconstructPar.C
index e7e1d52255bb1f9422a8aadbfcc45c856d815c75..defbca4c6925e8b6e4a0483389153e46023341f6 100644
--- a/applications/utilities/parallelProcessing/reconstructPar/reconstructPar.C
+++ b/applications/utilities/parallelProcessing/reconstructPar/reconstructPar.C
@@ -706,10 +706,17 @@ int main(int argc, char *argv[])
                 {
                     const fvMesh& procMesh = procMeshes.meshes()[procI];
 
+                    // Note: look at sets in current time only or between
+                    // mesh and current time?. For now current time. This will
+                    // miss out on sets in intermediate times that have not
+                    // been reconstructed.
                     IOobjectList objects
                     (
-                        procMesh, procMesh.facesInstance(), "polyMesh/sets"
+                        procMesh,
+                        databases[0].timeName(),    //procMesh.facesInstance()
+                        polyMesh::meshSubDir/"sets"
                     );
+
                     IOobjectList cSets(objects.lookupClass(cellSet::typeName));
                     forAllConstIter(IOobjectList, cSets, iter)
                     {
@@ -754,7 +761,9 @@ int main(int argc, char *argv[])
 
                     IOobjectList objects
                     (
-                        procMesh, procMesh.facesInstance(), "polyMesh/sets"
+                        procMesh,
+                        databases[0].timeName(),    //procMesh.facesInstance(),
+                        polyMesh::meshSubDir/"sets"
                     );
 
                     // cellSets
@@ -856,6 +865,9 @@ int main(int argc, char *argv[])
     // the master processor
     forAll(timeDirs, timeI)
     {
+        runTime.setTime(timeDirs[timeI], timeI);
+        databases[0].setTime(timeDirs[timeI], timeI);
+
         fileName uniformDir0 = databases[0].timePath()/"uniform";
         if (isDir(uniformDir0))
         {
diff --git a/applications/utilities/surface/surfaceLambdaMuSmooth/surfaceLambdaMuSmooth.C b/applications/utilities/surface/surfaceLambdaMuSmooth/surfaceLambdaMuSmooth.C
index c76e466f83cd06bcedbbc4c4143fffb608171a74..cc1981e1d5dde1fdb61c099629e0e089fc1e196d 100644
--- a/applications/utilities/surface/surfaceLambdaMuSmooth/surfaceLambdaMuSmooth.C
+++ b/applications/utilities/surface/surfaceLambdaMuSmooth/surfaceLambdaMuSmooth.C
@@ -33,6 +33,9 @@ Description
     Provide an edgeMesh file containing points that are not to be moved during
     smoothing in order to preserve features.
 
+    lambda/mu smoothing: G. Taubin, IBM Research report Rc-19923 (02/01/95)
+    "A signal processing approach to fair surface design"
+
 \*---------------------------------------------------------------------------*/
 
 #include "argList.H"
diff --git a/src/OpenFOAM/db/IOstreams/Fstreams/OFstream.C b/src/OpenFOAM/db/IOstreams/Fstreams/OFstream.C
index 3feefdaf40a4cf74e0d11b2b21da741509712ed5..1a09b7f4739d36b3e80df09fb09ac30f67808b5d 100644
--- a/src/OpenFOAM/db/IOstreams/Fstreams/OFstream.C
+++ b/src/OpenFOAM/db/IOstreams/Fstreams/OFstream.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -104,10 +104,10 @@ Foam::OFstream::OFstream
     {
         if (debug)
         {
-            Info<< "IFstream::IFstream(const fileName&,"
-                   "streamFormat format=ASCII,"
-                   "versionNumber version=currentVersion) : "
-                   "could not open file for input\n"
+            Info<< "OFstream::OFstream(const fileName&,"
+                   "streamFormat, versionNumber, compressionType) : "
+                   "could not open file " << pathname
+                << "for input\n"
                    "in stream " << info() << Foam::endl;
         }
 
diff --git a/src/OpenFOAM/db/IOstreams/Pstreams/PstreamBuffers.C b/src/OpenFOAM/db/IOstreams/Pstreams/PstreamBuffers.C
index a1db6529f1a91570223d21aa998ed938a3b957a6..dfb60891d6cfcd71cc0d3fefceaaa7923b1f3ae5 100644
--- a/src/OpenFOAM/db/IOstreams/Pstreams/PstreamBuffers.C
+++ b/src/OpenFOAM/db/IOstreams/Pstreams/PstreamBuffers.C
@@ -145,4 +145,19 @@ void Foam::PstreamBuffers::finishedSends(labelListList& sizes, const bool block)
 }
 
 
+void Foam::PstreamBuffers::clear()
+{
+    forAll(sendBuf_, i)
+    {
+        sendBuf_[i].clear();
+    }
+    forAll(recvBuf_, i)
+    {
+        recvBuf_[i].clear();
+    }
+    recvBufPos_ = 0;
+    finishedSendsCalled_ = false;
+}
+
+
 // ************************************************************************* //
diff --git a/src/OpenFOAM/db/IOstreams/Pstreams/PstreamBuffers.H b/src/OpenFOAM/db/IOstreams/Pstreams/PstreamBuffers.H
index 52b9960bde479e99036b4e12a9bad949587e1c5d..8d5998fe8286016c0d0428ce930c2970338ef2a4 100644
--- a/src/OpenFOAM/db/IOstreams/Pstreams/PstreamBuffers.H
+++ b/src/OpenFOAM/db/IOstreams/Pstreams/PstreamBuffers.H
@@ -112,8 +112,6 @@ class PstreamBuffers
 
         bool finishedSendsCalled_;
 
-    // Private Member Functions
-
 public:
 
     // Static data
@@ -155,6 +153,9 @@ public:
         //  non-blocking.
         void finishedSends(labelListList& sizes, const bool block = true);
 
+        //- Clear storage and reset
+        void clear();
+
 };
 
 
diff --git a/src/OpenFOAM/meshes/MeshObject/MeshObject.C b/src/OpenFOAM/meshes/MeshObject/MeshObject.C
index 1a8ebe937a6ce362bb63416f86e4b5f19fcec050..546c3d1c98dc2afb8e48a1ad6efde01989ede031 100644
--- a/src/OpenFOAM/meshes/MeshObject/MeshObject.C
+++ b/src/OpenFOAM/meshes/MeshObject/MeshObject.C
@@ -374,4 +374,32 @@ void Foam::meshObject::clear(objectRegistry& obr)
 }
 
 
+template
+<
+    class Mesh,
+    template<class> class FromType,
+    template<class> class ToType
+>
+void Foam::meshObject::clearUpto(objectRegistry& obr)
+{
+    HashTable<FromType<Mesh>*> meshObjects
+    (
+        obr.lookupClass<FromType<Mesh> >()
+    );
+
+    forAllIter(typename HashTable<FromType<Mesh>*>, meshObjects, iter)
+    {
+        if (!isA<ToType<Mesh> >(*iter()))
+        {
+            if (meshObject::debug)
+            {
+                Pout<< "meshObject::clearUpto(objectRegistry&) : destroying "
+                    << iter()->name() << endl;
+            }
+            obr.checkOut(*iter());
+        }
+    }
+}
+
+
 // ************************************************************************* //
diff --git a/src/OpenFOAM/meshes/MeshObject/MeshObject.H b/src/OpenFOAM/meshes/MeshObject/MeshObject.H
index b95c631e52fe1147c297d3d2645ad93130fe6d2a..bc844bd1eb1c05203394eb61b24e0a1414792780 100644
--- a/src/OpenFOAM/meshes/MeshObject/MeshObject.H
+++ b/src/OpenFOAM/meshes/MeshObject/MeshObject.H
@@ -182,6 +182,16 @@ public:
 
         template<class Mesh, template<class> class MeshObjectType>
         static void clear(objectRegistry&);
+
+        //- Clear all meshObject derived from FromType up to (but not including)
+        //  ToType. Used to clear e.g. all non-updateable meshObjects
+        template
+        <
+            class Mesh,
+            template<class> class FromType,
+            template<class> class ToType
+        >
+        static void clearUpto(objectRegistry&);
 };
 
 
diff --git a/src/OpenFOAM/meshes/polyMesh/polyMesh.C b/src/OpenFOAM/meshes/polyMesh/polyMesh.C
index af15b5edf56f756b504def0e59d1293a95e49853..162e895170999fe2f37d9266765b6fdf44a8610e 100644
--- a/src/OpenFOAM/meshes/polyMesh/polyMesh.C
+++ b/src/OpenFOAM/meshes/polyMesh/polyMesh.C
@@ -265,7 +265,7 @@ Foam::polyMesh::polyMesh(const IOobject& io)
     ),
     globalMeshDataPtr_(NULL),
     moving_(false),
-    changing_(false),
+    topoChanging_(false),
     curMotionTimeIndex_(time().timeIndex()),
     oldPointsPtr_(NULL)
 {
@@ -447,7 +447,7 @@ Foam::polyMesh::polyMesh
     ),
     globalMeshDataPtr_(NULL),
     moving_(false),
-    changing_(false),
+    topoChanging_(false),
     curMotionTimeIndex_(time().timeIndex()),
     oldPointsPtr_(NULL)
 {
@@ -606,7 +606,7 @@ Foam::polyMesh::polyMesh
     ),
     globalMeshDataPtr_(NULL),
     moving_(false),
-    changing_(false),
+    topoChanging_(false),
     curMotionTimeIndex_(time().timeIndex()),
     oldPointsPtr_(NULL)
 {
@@ -673,8 +673,8 @@ void Foam::polyMesh::resetPrimitives
     const bool validBoundary
 )
 {
-    // Clear addressing. Keep geometric props for mapping.
-    clearAddressing();
+    // Clear addressing. Keep geometric props and updateable props for mapping.
+    clearAddressing(true);
 
     // Take over new primitive data.
     // Optimized to avoid overwriting data at all
diff --git a/src/OpenFOAM/meshes/polyMesh/polyMesh.H b/src/OpenFOAM/meshes/polyMesh/polyMesh.H
index 47fe014d60cee03752bed1f9a8b95974e1dbe560..5d95d9cfb876a258b2c89dc5f8e2dbbc3ea7e169 100644
--- a/src/OpenFOAM/meshes/polyMesh/polyMesh.H
+++ b/src/OpenFOAM/meshes/polyMesh/polyMesh.H
@@ -172,8 +172,8 @@ private:
             //- Is the mesh moving
             bool moving_;
 
-            //- Is the mesh changing (moving and/or topology changing)
-            bool changing_;
+            //- Is the mesh topology changing
+            bool topoChanging_;
 
             //- Current time index for mesh motion
             mutable label curMotionTimeIndex_;
@@ -489,24 +489,29 @@ public:
             {
                 bool m0 = moving_;
                 moving_ = m;
-                changing_ = changing_ || moving_;
                 return m0;
             }
 
-            //- Is mesh changing (topology changing and/or moving)
-            bool changing() const
+            //- Is mesh topology changing
+            bool topoChanging() const
             {
-                return changing_;
+                return topoChanging_;
             }
 
-            //- Set the mesh to be changing
-            bool changing(const bool c)
+            //- Set the mesh topology to be changing
+            bool topoChanging(const bool c)
             {
-                bool c0 = changing_;
-                changing_ = c;
+                bool c0 = topoChanging_;
+                topoChanging_ = c;
                 return c0;
             }
 
+            //- Is mesh changing (topology changing and/or moving)
+            bool changing() const
+            {
+                return moving()||topoChanging();
+            }
+
             //- Move points, returns volumes swept by faces in motion
             virtual tmp<scalarField> movePoints(const pointField&);
 
@@ -580,7 +585,7 @@ public:
             void clearGeom();
 
             //- Clear addressing
-            void clearAddressing();
+            void clearAddressing(const bool isMeshUpdate = false);
 
             //- Clear all geometry and addressing unnecessary for CFD
             void clearOut();
diff --git a/src/OpenFOAM/meshes/polyMesh/polyMeshClear.C b/src/OpenFOAM/meshes/polyMesh/polyMeshClear.C
index 7a9558187d54f0b862f09f14be06ff8b59058911..96297ed3e107e79eab6277796f832742b11eddbe 100644
--- a/src/OpenFOAM/meshes/polyMesh/polyMeshClear.C
+++ b/src/OpenFOAM/meshes/polyMesh/polyMeshClear.C
@@ -60,6 +60,7 @@ void Foam::polyMesh::clearGeom()
             << endl;
     }
 
+    // Clear all geometric mesh objects
     meshObject::clear<polyMesh, GeometricMeshObject>(*this);
 
     primitiveMesh::clearGeom();
@@ -93,16 +94,33 @@ void Foam::polyMesh::clearAdditionalGeom()
 }
 
 
-void Foam::polyMesh::clearAddressing()
+void Foam::polyMesh::clearAddressing(const bool isMeshUpdate)
 {
     if (debug)
     {
         Info<< "void polyMesh::clearAddressing() : "
-            << "clearing topology"
+            << "clearing topology  isMeshUpdate:" << isMeshUpdate
             << endl;
     }
 
-    meshObject::clear<polyMesh, TopologicalMeshObject>(*this);
+    if (isMeshUpdate)
+    {
+        // Part of a mesh update. Keep meshObjects that have an updateMesh
+        // callback
+        meshObject::clearUpto
+        <
+            polyMesh,
+            TopologicalMeshObject,
+            UpdateableMeshObject
+        >
+        (
+            *this
+        );
+    }
+    else
+    {
+        meshObject::clear<polyMesh, TopologicalMeshObject>(*this);
+    }
 
     primitiveMesh::clearAddressing();
 
diff --git a/src/OpenFOAM/meshes/polyMesh/polyMeshFromShapeMesh.C b/src/OpenFOAM/meshes/polyMesh/polyMeshFromShapeMesh.C
index 43d55876cac08c0823a089f0be6dbf638d2fcee1..ef5ee9956c3b7fb071ec5264de5dd590aaf683fd 100644
--- a/src/OpenFOAM/meshes/polyMesh/polyMeshFromShapeMesh.C
+++ b/src/OpenFOAM/meshes/polyMesh/polyMeshFromShapeMesh.C
@@ -553,7 +553,7 @@ Foam::polyMesh::polyMesh
     ),
     globalMeshDataPtr_(NULL),
     moving_(false),
-    changing_(false),
+    topoChanging_(false),
     curMotionTimeIndex_(time().timeIndex()),
     oldPointsPtr_(NULL)
 {
@@ -837,7 +837,7 @@ Foam::polyMesh::polyMesh
     ),
     globalMeshDataPtr_(NULL),
     moving_(false),
-    changing_(false),
+    topoChanging_(false),
     curMotionTimeIndex_(time().timeIndex()),
     oldPointsPtr_(NULL)
 {
diff --git a/src/OpenFOAM/meshes/polyMesh/polyPatches/constraint/symmetryPlane/symmetryPlanePolyPatch.C b/src/OpenFOAM/meshes/polyMesh/polyPatches/constraint/symmetryPlane/symmetryPlanePolyPatch.C
index 49b48f8df7c902d4d54aa954f347b68b4fc4b17b..5061538f4c64c5a63955fd2133167c4c2ffe8ebe 100644
--- a/src/OpenFOAM/meshes/polyMesh/polyPatches/constraint/symmetryPlane/symmetryPlanePolyPatch.C
+++ b/src/OpenFOAM/meshes/polyMesh/polyPatches/constraint/symmetryPlane/symmetryPlanePolyPatch.C
@@ -114,17 +114,26 @@ const Foam::vector& Foam::symmetryPlanePolyPatch::n() const
     // as the average face-normal
     if (magSqr(n_) < 0.5)
     {
-        const vectorField& nf(faceNormals());
-        n_ = gAverage(nf);
-
-        // Check the symmetry plane is planar
-        forAll(nf, facei)
+        if (returnReduce(size(), sumOp<label>()) == 0)
+        {
+            // No faces in patch. Avoid gAverage complaining and set
+            // normal to nonsense value to catch any use
+            n_ = vector::rootMax;
+        }
+        else
         {
-            if (magSqr(n_ - nf[facei]) > SMALL)
+            const vectorField& nf(faceNormals());
+            n_ = gAverage(nf);
+
+            // Check the symmetry plane is planar
+            forAll(nf, facei)
             {
-                FatalErrorIn("symmetryPlanePolyPatch::n()")
-                    << "Symmetry plane '" << name() << "' is not planar"
-                    << exit(FatalError);
+                if (magSqr(n_ - nf[facei]) > SMALL)
+                {
+                    FatalErrorIn("symmetryPlanePolyPatch::n()")
+                        << "Symmetry plane '" << name() << "' is not planar"
+                        << exit(FatalError);
+                }
             }
         }
     }
diff --git a/src/OpenFOAM/meshes/primitiveMesh/primitiveMeshCellCentresAndVols.C b/src/OpenFOAM/meshes/primitiveMesh/primitiveMeshCellCentresAndVols.C
index 41e5366c9ae73d49b0bff67299e93d2fb9acc3e9..bd58fe39a9920ba144a28c1f3a4ebaf6dd710e10 100644
--- a/src/OpenFOAM/meshes/primitiveMesh/primitiveMeshCellCentresAndVols.C
+++ b/src/OpenFOAM/meshes/primitiveMesh/primitiveMeshCellCentresAndVols.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-2013 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -111,7 +111,7 @@ void Foam::primitiveMesh::makeCellCentresAndVols
     {
         // Calculate 3*face-pyramid volume
         scalar pyr3Vol =
-            max(fAreas[facei] & (fCtrs[facei] - cEst[own[facei]]), VSMALL);
+            fAreas[facei] & (fCtrs[facei] - cEst[own[facei]]);
 
         // Calculate face-pyramid centre
         vector pc = (3.0/4.0)*fCtrs[facei] + (1.0/4.0)*cEst[own[facei]];
@@ -127,7 +127,7 @@ void Foam::primitiveMesh::makeCellCentresAndVols
     {
         // Calculate 3*face-pyramid volume
         scalar pyr3Vol =
-            max(fAreas[facei] & (cEst[nei[facei]] - fCtrs[facei]), VSMALL);
+            fAreas[facei] & (cEst[nei[facei]] - fCtrs[facei]);
 
         // Calculate face-pyramid centre
         vector pc = (3.0/4.0)*fCtrs[facei] + (1.0/4.0)*cEst[nei[facei]];
@@ -139,7 +139,18 @@ void Foam::primitiveMesh::makeCellCentresAndVols
         cellVols[nei[facei]] += pyr3Vol;
     }
 
-    cellCtrs /= cellVols;
+    forAll(cellCtrs, celli)
+    {
+        if (cellVols[celli] > VSMALL)
+        {
+            cellCtrs[celli] /= cellVols[celli];
+        }
+        else
+        {
+            cellCtrs[celli] = cEst[celli];
+        }
+    }
+
     cellVols *= (1.0/3.0);
 }
 
diff --git a/src/dynamicFvMesh/dynamicRefineFvMesh/dynamicRefineFvMesh.C b/src/dynamicFvMesh/dynamicRefineFvMesh/dynamicRefineFvMesh.C
index 77fc1f26ca7b18439bb2f1ab57b2b63c13c2f210..bfc6b567f45db7b1e2f6bca7a933227fa55c65df 100644
--- a/src/dynamicFvMesh/dynamicRefineFvMesh/dynamicRefineFvMesh.C
+++ b/src/dynamicFvMesh/dynamicRefineFvMesh/dynamicRefineFvMesh.C
@@ -32,6 +32,7 @@ License
 #include "syncTools.H"
 #include "pointFields.H"
 #include "sigFpe.H"
+#include "cellSet.H"
 
 // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
 
@@ -1072,6 +1073,26 @@ Foam::dynamicRefineFvMesh::dynamicRefineFvMesh(const IOobject& io)
     {
         protectedCell_.clear();
     }
+    else
+    {
+
+        cellSet protectedCells(*this, "protectedCells", nProtected);
+        forAll(protectedCell_, cellI)
+        {
+            if (protectedCell_[cellI])
+            {
+                protectedCells.insert(cellI);
+            }
+        }
+
+        Info<< "Detected " << returnReduce(nProtected, sumOp<label>())
+            << " cells that are projected from refinement."
+            << " Writing these to cellSet "
+            << protectedCells.name()
+            << "." << endl;
+
+        protectedCells.write();
+    }
 }
 
 
@@ -1110,7 +1131,7 @@ bool Foam::dynamicRefineFvMesh::update()
 
     if (refineInterval == 0)
     {
-        changing(hasChanged);
+        topoChanging(hasChanged);
 
         return false;
     }
@@ -1279,7 +1300,13 @@ bool Foam::dynamicRefineFvMesh::update()
         nRefinementIterations_++;
     }
 
-    changing(hasChanged);
+    topoChanging(hasChanged);
+    if (hasChanged)
+    {
+        // Reset moving flag (if any). If not using inflation we'll not move,
+        // if are using inflation any follow on movePoints will set it.
+        moving(false);
+    }
 
     return hasChanged;
 }
diff --git a/src/dynamicMesh/motionSmoother/motionSmootherAlgo.C b/src/dynamicMesh/motionSmoother/motionSmootherAlgo.C
index a953c66ea6cec8f555429309a11808edee84bd66..b817777a3e3ea0a96f6d2bc22e8a50d03bcb8b97 100644
--- a/src/dynamicMesh/motionSmoother/motionSmootherAlgo.C
+++ b/src/dynamicMesh/motionSmoother/motionSmootherAlgo.C
@@ -169,7 +169,7 @@ void Foam::motionSmootherAlgo::minSmooth
     }
 
     // Single and multi-patch constraints
-    pointConstraints::New(mesh()).constrain(newFld, false);
+    pointConstraints::New(pMesh()).constrain(newFld, false);
 }
 
 
@@ -202,7 +202,7 @@ void Foam::motionSmootherAlgo::minSmooth
     }
 
    // Single and multi-patch constraints
-    pointConstraints::New(mesh()).constrain(newFld, false);
+    pointConstraints::New(pMesh()).constrain(newFld, false);
 
 }
 
@@ -224,7 +224,7 @@ void Foam::motionSmootherAlgo::scaleField
     }
 
     // Single and multi-patch constraints
-    pointConstraints::New(mesh()).constrain(fld, false);
+    pointConstraints::New(pMesh()).constrain(fld, false);
 }
 
 
@@ -266,7 +266,7 @@ void Foam::motionSmootherAlgo::subtractField
     }
 
     // Single and multi-patch constraints
-    pointConstraints::New(mesh()).constrain(fld);
+    pointConstraints::New(pMesh()).constrain(fld);
 }
 
 
@@ -476,7 +476,7 @@ void Foam::motionSmootherAlgo::setDisplacementPatchFields
     }
 
     // Multi-patch constraints
-    pointConstraints::New(displacement.mesh()()).constrainCorners(displacement);
+    pointConstraints::New(displacement.mesh()).constrainCorners(displacement);
 
     // Adapt the fixedValue bc's (i.e. copy internal point data to
     // boundaryField for all affected patches) to take the changes caused
@@ -622,7 +622,7 @@ void Foam::motionSmootherAlgo::correctBoundaryConditions
     }
 
     // Multi-patch constraints
-    pointConstraints::New(displacement.mesh()()).constrainCorners(displacement);
+    pointConstraints::New(displacement.mesh()).constrainCorners(displacement);
 
     // Correct for problems introduced by corner constraints
     syncTools::syncPointList
diff --git a/src/dynamicMesh/motionSmoother/motionSmootherAlgoTemplates.C b/src/dynamicMesh/motionSmoother/motionSmootherAlgoTemplates.C
index f78a11a9a3810541d6da13e50c52df536b34b18f..17730d131ef1bfbaefa5d17048f224ef3a9d5d35 100644
--- a/src/dynamicMesh/motionSmoother/motionSmootherAlgoTemplates.C
+++ b/src/dynamicMesh/motionSmoother/motionSmootherAlgoTemplates.C
@@ -229,7 +229,7 @@ Foam::motionSmootherAlgo::avg
     }
 
     // Single and multi-patch constraints
-    pointConstraints::New(mesh).constrain(res, false);
+    pointConstraints::New(fld.mesh()).constrain(res, false);
 
     return tres;
 }
@@ -256,7 +256,7 @@ void Foam::motionSmootherAlgo::smooth
     }
 
     // Single and multi-patch constraints
-    pointConstraints::New(mesh_).constrain(newFld, false);
+    pointConstraints::New(fld.mesh()).constrain(newFld, false);
 }
 
 
diff --git a/src/dynamicMesh/motionSolver/motionSolver/motionSolver.C b/src/dynamicMesh/motionSolver/motionSolver/motionSolver.C
index 01f37cbf62247749acc5cdf0b650df385a2c795a..5613ac6b4103f435b47868192734bd63237e8065 100644
--- a/src/dynamicMesh/motionSolver/motionSolver/motionSolver.C
+++ b/src/dynamicMesh/motionSolver/motionSolver/motionSolver.C
@@ -190,4 +190,19 @@ bool Foam::motionSolver::writeObject
 }
 
 
+bool Foam::motionSolver::read()
+{
+    if (regIOobject::read())
+    {
+        coeffDict_ = subDict(type() + "Coeffs");
+
+        return true;
+    }
+    else
+    {
+        return false;
+    }
+}
+
+
 // ************************************************************************* //
diff --git a/src/dynamicMesh/motionSolver/motionSolver/motionSolver.H b/src/dynamicMesh/motionSolver/motionSolver/motionSolver.H
index 7a53d4e81d7bd7582bd4a0195cb7772f76f4452f..651c0d9d1831f399c8bc5bf25188a762ef0d31d3 100644
--- a/src/dynamicMesh/motionSolver/motionSolver/motionSolver.H
+++ b/src/dynamicMesh/motionSolver/motionSolver/motionSolver.H
@@ -156,6 +156,9 @@ public:
             IOstream::versionNumber ver,
             IOstream::compressionType cmp
         ) const;
+
+        //- Read dynamicMeshDict dictionary
+        virtual bool read();
 };
 
 
diff --git a/src/dynamicMesh/polyTopoChange/polyTopoChange/polyTopoChange.C b/src/dynamicMesh/polyTopoChange/polyTopoChange/polyTopoChange.C
index bb53ef1aa02bc86ba1b8105866bab097b4f9cf1e..f35ebd881ceb0e494c2f094675d6e5e9e2503b97 100644
--- a/src/dynamicMesh/polyTopoChange/polyTopoChange/polyTopoChange.C
+++ b/src/dynamicMesh/polyTopoChange/polyTopoChange/polyTopoChange.C
@@ -3184,7 +3184,9 @@ Foam::autoPtr<Foam::mapPolyMesh> Foam::polyTopoChange::changeMesh
             syncParallel
         );
 
-        mesh.changing(true);
+        mesh.topoChanging(true);
+        // Note: could already set moving flag as well
+        //       mesh.moving(true);
     }
     else
     {
@@ -3199,7 +3201,7 @@ Foam::autoPtr<Foam::mapPolyMesh> Foam::polyTopoChange::changeMesh
             patchStarts,
             syncParallel
         );
-        mesh.changing(true);
+        mesh.topoChanging(true);
     }
 
     // Clear out primitives
diff --git a/src/edgeMesh/Make/files b/src/edgeMesh/Make/files
index 70c5178cbe1768a680e853ef8ca89afdb1eb7d0e..0438dd204ecc140496f78f4c18a567406a645bd4 100644
--- a/src/edgeMesh/Make/files
+++ b/src/edgeMesh/Make/files
@@ -1,13 +1,20 @@
-edgeMesh.C
-edgeMeshIO.C
-edgeMeshNew.C
+em = .
 
-edgeMeshFormats = edgeMeshFormats
+$(em)/edgeMesh.C
+$(em)/edgeMeshIO.C
+$(em)/edgeMeshNew.C
+
+
+edgeMeshFormats = $(em)/edgeMeshFormats
 $(edgeMeshFormats)/edgeMeshFormatsCore.C
 
 $(edgeMeshFormats)/edgeMesh/edgeMeshFormat.C
 $(edgeMeshFormats)/edgeMesh/edgeMeshFormatRunTime.C
 
+$(edgeMeshFormats)/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshFormat.C
+$(edgeMeshFormats)/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshFormatRunTime.C
+
+
 $(edgeMeshFormats)/nas/NASedgeFormat.C
 $(edgeMeshFormats)/nas/NASedgeFormatRunTime.C
 
@@ -20,9 +27,20 @@ $(edgeMeshFormats)/starcd/STARCDedgeFormatRunTime.C
 $(edgeMeshFormats)/vtk/VTKedgeFormat.C
 $(edgeMeshFormats)/vtk/VTKedgeFormatRunTime.C
 
-extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.C
 
-featureEdgeMesh/featureEdgeMesh.C
+$(em)/featureEdgeMesh/featureEdgeMesh.C
+
+eem = $(em)/extendedEdgeMesh
+
+$(eem)/extendedEdgeMesh.C
+$(eem)/extendedEdgeMeshNew.C
+
+$(eem)/extendedEdgeMeshFormats/extendedEdgeMeshFormat/extendedEdgeMeshFormat.C
+$(eem)/extendedEdgeMeshFormats/extendedEdgeMeshFormat/extendedEdgeMeshFormatRunTime.C
+
+efm = $(eem)/extendedFeatureEdgeMesh
+
+$(efm)/extendedFeatureEdgeMesh.C
 
 
 
diff --git a/src/edgeMesh/Make/options b/src/edgeMesh/Make/options
index 3c1b5258d3451f8b610bd8ddaa25f56e3efae601..61439e40e2654c4db581a973662a613ec0624b8f 100644
--- a/src/edgeMesh/Make/options
+++ b/src/edgeMesh/Make/options
@@ -1,9 +1,11 @@
 EXE_INC = \
     -I$(LIB_SRC)/fileFormats/lnInclude \
+    -I$(LIB_SRC)/surfMesh/lnInclude \
     -I$(LIB_SRC)/triSurface/lnInclude \
     -I$(LIB_SRC)/meshTools/lnInclude
 
 LIB_LIBS = \
     -ltriSurface \
     -lmeshTools \
-    -lfileFormats
+    -lfileFormats \
+    -lsurfMesh
diff --git a/src/edgeMesh/edgeMesh.H b/src/edgeMesh/edgeMesh.H
index c8abb55169d6cb374630822dc7b612e13e44a7d2..d3397a290b0816f233172ec779caef371f01b30c 100644
--- a/src/edgeMesh/edgeMesh.H
+++ b/src/edgeMesh/edgeMesh.H
@@ -27,6 +27,9 @@ Class
 Description
     Points connected by edges.
 
+    Can be read from fileName based on extension. Uses ::New factory method
+    to select the reader and transfer the result.
+
 SourceFiles
     edgeMeshI.H
     edgeMesh.C
@@ -253,7 +256,7 @@ public:
 
     // Write
 
-        void writeStats(Ostream&) const;
+        virtual void writeStats(Ostream&) const;
 
         //- Generic write routine. Chooses writer based on extension.
         virtual void write(const fileName& name) const
diff --git a/src/edgeMesh/edgeMeshFormats/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshFormat.C b/src/edgeMesh/edgeMeshFormats/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshFormat.C
new file mode 100644
index 0000000000000000000000000000000000000000..5f20b3016b343e631dfa207c695a844a5fbc4a36
--- /dev/null
+++ b/src/edgeMesh/edgeMeshFormats/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshFormat.C
@@ -0,0 +1,70 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "extendedFeatureEdgeMeshFormat.H"
+#include "edgeMeshFormat.H"
+#include "IFstream.H"
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::fileFormats::extendedFeatureEdgeMeshFormat::extendedFeatureEdgeMeshFormat
+(
+    const fileName& filename
+)
+{
+    read(filename);
+}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+bool Foam::fileFormats::extendedFeatureEdgeMeshFormat::read
+(
+    const fileName& filename
+)
+{
+    clear();
+
+    IFstream is(filename);
+    if (!is.good())
+    {
+        FatalErrorIn
+        (
+            "fileFormats::extendedFeatureEdgeMeshFormat::read(const fileName&)"
+        )
+            << "Cannot read file " << filename
+            << exit(FatalError);
+    }
+
+    return fileFormats::edgeMeshFormat::read
+    (
+        is,
+        this->storedPoints(),
+        this->storedEdges()
+    );
+}
+
+
+// ************************************************************************* //
diff --git a/src/edgeMesh/edgeMeshFormats/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshFormat.H b/src/edgeMesh/edgeMeshFormats/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshFormat.H
new file mode 100644
index 0000000000000000000000000000000000000000..cabc9beec0cbdeec8da2294f03f57b1e715f8510
--- /dev/null
+++ b/src/edgeMesh/edgeMeshFormats/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshFormat.H
@@ -0,0 +1,106 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::fileFormats::extendedFeatureEdgeMeshFormat
+
+Description
+    Provide a means of reading extendedFeatureEdgeMesh as featureEdgeMesh
+
+SourceFiles
+    extendedFeatureEdgeMeshFormat.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef extendedFeatureEdgeMeshFormat_H
+#define extendedFeatureEdgeMeshFormat_H
+
+#include "edgeMesh.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace fileFormats
+{
+
+/*---------------------------------------------------------------------------*\
+                        Class extendedFeatureEdgeMeshFormat Declaration
+\*---------------------------------------------------------------------------*/
+
+class extendedFeatureEdgeMeshFormat
+:
+    public edgeMesh
+{
+    // Private Member Functions
+
+        //- Disallow default bitwise copy construct
+        extendedFeatureEdgeMeshFormat(const extendedFeatureEdgeMeshFormat&);
+
+        //- Disallow default bitwise assignment
+        void operator=(const extendedFeatureEdgeMeshFormat&);
+
+
+public:
+
+    // Constructors
+
+        //- Construct from file name
+        extendedFeatureEdgeMeshFormat(const fileName&);
+
+
+    // Selectors
+
+        //- Read file and return surface
+        static autoPtr<edgeMesh> New(const fileName& name)
+        {
+            return autoPtr<edgeMesh>
+            (
+                new extendedFeatureEdgeMeshFormat(name)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~extendedFeatureEdgeMeshFormat()
+    {}
+
+
+    // Member Functions
+
+        //- Read from file
+        virtual bool read(const fileName&);
+
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace fileFormats
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/edgeMesh/edgeMeshFormats/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshFormatRunTime.C b/src/edgeMesh/edgeMeshFormats/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshFormatRunTime.C
new file mode 100644
index 0000000000000000000000000000000000000000..958f99facb7a08bf71748b188d76c1beb4b9b922
--- /dev/null
+++ b/src/edgeMesh/edgeMeshFormats/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshFormatRunTime.C
@@ -0,0 +1,50 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "extendedFeatureEdgeMeshFormat.H"
+
+#include "addToRunTimeSelectionTable.H"
+#include "addToMemberFunctionSelectionTable.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace fileFormats
+{
+
+// read extendedEdgeMesh
+addNamedToRunTimeSelectionTable
+(
+    edgeMesh,
+    extendedFeatureEdgeMeshFormat,
+    fileExtension,
+    featureEdgeMesh
+);
+
+}
+}
+
+// ************************************************************************* //
diff --git a/src/edgeMesh/edgeMeshIO.C b/src/edgeMesh/edgeMeshIO.C
index 08e1398a36dad538d0acafea6eae0ec190eba68a..3887f9d67921cc0e3ab1f77fe3c1fb307c737fa9 100644
--- a/src/edgeMesh/edgeMeshIO.C
+++ b/src/edgeMesh/edgeMeshIO.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -122,9 +122,9 @@ void Foam::edgeMesh::write
 
 void Foam::edgeMesh::writeStats(Ostream& os) const
 {
-    os  << "points      : " << points().size() << nl;
-    os  << "edges       : " << edges().size() << nl;
-    os  << "boundingBox : " << boundBox(this->points()) << endl;
+    os  << indent << "points      : " << points().size() << nl;
+    os  << indent << "edges       : " << edges().size() << nl;
+    os  << indent << "boundingBox : " << boundBox(this->points()) << endl;
 }
 
 
diff --git a/src/edgeMesh/edgeMeshNew.C b/src/edgeMesh/edgeMeshNew.C
index da7091c73a9559088aeb0c9babba386298955ba5..df52d7cf6386c346b4ce5c8729fba6cf2c92b557 100644
--- a/src/edgeMesh/edgeMeshNew.C
+++ b/src/edgeMesh/edgeMeshNew.C
@@ -42,8 +42,9 @@ Foam::autoPtr<Foam::edgeMesh> Foam::edgeMesh::New
         (
             "edgeMesh<Face>::New(const fileName&, const word&) : "
             "constructing edgeMesh"
-        )   << "Unknown file extension " << ext << nl << nl
-            << "Valid types are :" << nl
+        )   << "Unknown file extension " << ext
+            << " for file " << name << nl << nl
+            << "Valid extensions are :" << nl
             << fileExtensionConstructorTablePtr_->sortedToc()
             << exit(FatalError);
     }
diff --git a/src/edgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.C b/src/edgeMesh/extendedEdgeMesh/extendedEdgeMesh.C
similarity index 73%
rename from src/edgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.C
rename to src/edgeMesh/extendedEdgeMesh/extendedEdgeMesh.C
index 0d03912ceed215ebfc9fb6b96d267912bac487be..5ac41224e3a6cce1b5af9054c3d7e8e57694fe9e 100644
--- a/src/edgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.C
+++ b/src/edgeMesh/extendedEdgeMesh/extendedEdgeMesh.C
@@ -23,28 +23,25 @@ License
 
 \*---------------------------------------------------------------------------*/
 
-#include "extendedFeatureEdgeMesh.H"
+#include "extendedEdgeMesh.H"
 #include "surfaceFeatures.H"
 #include "triSurface.H"
 #include "Random.H"
 #include "Time.H"
-#include "meshTools.H"
-#include "ListListOps.H"
-#include "OFstream.H"
-#include "IFstream.H"
-#include "unitConversion.H"
+#include "OBJstream.H"
 #include "DynamicField.H"
+#include "edgeMeshFormatsCore.H"
 
 // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
 
 namespace Foam
 {
-    defineTypeNameAndDebug(extendedFeatureEdgeMesh, 0);
+    defineTypeNameAndDebug(extendedEdgeMesh, 0);
 
     template<>
     const char* Foam::NamedEnum
     <
-        Foam::extendedFeatureEdgeMesh::pointStatus,
+        Foam::extendedEdgeMesh::pointStatus,
         4
     >::names[] =
     {
@@ -57,7 +54,7 @@ namespace Foam
     template<>
     const char* Foam::NamedEnum
     <
-        Foam::extendedFeatureEdgeMesh::edgeStatus,
+        Foam::extendedEdgeMesh::edgeStatus,
         6
     >::names[] =
     {
@@ -72,7 +69,7 @@ namespace Foam
     template<>
     const char* Foam::NamedEnum
     <
-        Foam::extendedFeatureEdgeMesh::sideVolumeType,
+        Foam::extendedEdgeMesh::sideVolumeType,
         4
     >::names[] =
     {
@@ -83,36 +80,190 @@ namespace Foam
     };
 }
 
-const Foam::NamedEnum<Foam::extendedFeatureEdgeMesh::pointStatus, 4>
-    Foam::extendedFeatureEdgeMesh::pointStatusNames_;
+const Foam::NamedEnum<Foam::extendedEdgeMesh::pointStatus, 4>
+    Foam::extendedEdgeMesh::pointStatusNames_;
 
-const Foam::NamedEnum<Foam::extendedFeatureEdgeMesh::edgeStatus, 6>
-    Foam::extendedFeatureEdgeMesh::edgeStatusNames_;
+const Foam::NamedEnum<Foam::extendedEdgeMesh::edgeStatus, 6>
+    Foam::extendedEdgeMesh::edgeStatusNames_;
 
-const Foam::NamedEnum<Foam::extendedFeatureEdgeMesh::sideVolumeType, 4>
-    Foam::extendedFeatureEdgeMesh::sideVolumeTypeNames_;
+const Foam::NamedEnum<Foam::extendedEdgeMesh::sideVolumeType, 4>
+    Foam::extendedEdgeMesh::sideVolumeTypeNames_;
 
-Foam::scalar Foam::extendedFeatureEdgeMesh::cosNormalAngleTol_ =
+Foam::scalar Foam::extendedEdgeMesh::cosNormalAngleTol_ =
     Foam::cos(degToRad(0.1));
 
 
-Foam::label Foam::extendedFeatureEdgeMesh::convexStart_ = 0;
+Foam::label Foam::extendedEdgeMesh::convexStart_ = 0;
 
 
-Foam::label Foam::extendedFeatureEdgeMesh::externalStart_ = 0;
+Foam::label Foam::extendedEdgeMesh::externalStart_ = 0;
 
 
-Foam::label Foam::extendedFeatureEdgeMesh::nPointTypes = 4;
+Foam::label Foam::extendedEdgeMesh::nPointTypes = 4;
 
 
-Foam::label Foam::extendedFeatureEdgeMesh::nEdgeTypes = 5;
+Foam::label Foam::extendedEdgeMesh::nEdgeTypes = 5;
+
+
+Foam::wordHashSet Foam::extendedEdgeMesh::readTypes()
+{
+    return wordHashSet(*fileExtensionConstructorTablePtr_);
+}
+
+
+Foam::wordHashSet Foam::extendedEdgeMesh::writeTypes()
+{
+    return wordHashSet(*writefileExtensionMemberFunctionTablePtr_);
+}
+
+
+
+// * * * * * * * * * * * * * Static Member Functions * * * * * * * * * * * * //
+
+bool Foam::extendedEdgeMesh::canReadType
+(
+    const word& ext,
+    const bool verbose
+)
+{
+    return edgeMeshFormatsCore::checkSupport
+    (
+        readTypes(),
+        ext,
+        verbose,
+        "reading"
+   );
+}
+
+
+bool Foam::extendedEdgeMesh::canWriteType
+(
+    const word& ext,
+    const bool verbose
+)
+{
+    return edgeMeshFormatsCore::checkSupport
+    (
+        writeTypes(),
+        ext,
+        verbose,
+        "writing"
+    );
+}
+
+
+bool Foam::extendedEdgeMesh::canRead
+(
+    const fileName& name,
+    const bool verbose
+)
+{
+    word ext = name.ext();
+    if (ext == "gz")
+    {
+        ext = name.lessExt().ext();
+    }
+    return canReadType(ext, verbose);
+}
+
+
+// * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * * //
+
+Foam::extendedEdgeMesh::pointStatus
+Foam::extendedEdgeMesh::classifyFeaturePoint
+(
+    label ptI
+) const
+{
+    labelList ptEds(pointEdges()[ptI]);
+
+    label nPtEds = ptEds.size();
+    label nExternal = 0;
+    label nInternal = 0;
+
+    if (nPtEds == 0)
+    {
+        // There are no edges attached to the point, this is a problem
+        return NONFEATURE;
+    }
+
+    forAll(ptEds, i)
+    {
+        edgeStatus edStat = getEdgeStatus(ptEds[i]);
+
+        if (edStat == EXTERNAL)
+        {
+            nExternal++;
+        }
+        else if (edStat == INTERNAL)
+        {
+            nInternal++;
+        }
+    }
+
+    if (nExternal == nPtEds)
+    {
+        return CONVEX;
+    }
+    else if (nInternal == nPtEds)
+    {
+        return CONCAVE;
+    }
+    else
+    {
+        return MIXED;
+    }
+}
+
+
+Foam::extendedEdgeMesh::edgeStatus
+Foam::extendedEdgeMesh::classifyEdge
+(
+    const List<vector>& norms,
+    const labelList& edNorms,
+    const vector& fC0tofC1
+)
+{
+    label nEdNorms = edNorms.size();
+
+    if (nEdNorms == 1)
+    {
+        return OPEN;
+    }
+    else if (nEdNorms == 2)
+    {
+        const vector& n0(norms[edNorms[0]]);
+        const vector& n1(norms[edNorms[1]]);
+
+        if ((n0 & n1) > cosNormalAngleTol_)
+        {
+            return FLAT;
+        }
+        else if ((fC0tofC1 & n0) > 0.0)
+        {
+            return INTERNAL;
+        }
+        else
+        {
+            return EXTERNAL;
+        }
+    }
+    else if (nEdNorms > 2)
+    {
+        return MULTIPLE;
+    }
+    else
+    {
+        // There is a problem - the edge has no normals
+        return NONE;
+    }
+}
 
 
 // * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
 
-Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh(const IOobject& io)
+Foam::extendedEdgeMesh::extendedEdgeMesh()
 :
-    regIOobject(io),
     edgeMesh(pointField(0), edgeList(0)),
     concaveStart_(0),
     mixedStart_(0),
@@ -132,81 +283,14 @@ Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh(const IOobject& io)
     pointTree_(),
     edgeTree_(),
     edgeTreesByType_()
-{
-    if
-    (
-        io.readOpt() == IOobject::MUST_READ
-     || io.readOpt() == IOobject::MUST_READ_IF_MODIFIED
-     || (io.readOpt() == IOobject::READ_IF_PRESENT && headerOk())
-    )
-    {
-        if (readOpt() == IOobject::MUST_READ_IF_MODIFIED)
-        {
-            WarningIn
-            (
-                "extendedFeatureEdgeMesh::extendedFeatureEdgeMesh"
-                "(const IOobject&)"
-            )   << "Specified IOobject::MUST_READ_IF_MODIFIED but class"
-                << " does not support automatic rereading."
-                << endl;
-        }
-
-        Istream& is = readStream(typeName);
-
-        is  >> *this
-            >> concaveStart_
-            >> mixedStart_
-            >> nonFeatureStart_
-            >> internalStart_
-            >> flatStart_
-            >> openStart_
-            >> multipleStart_
-            >> normals_
-            >> normalVolumeTypes_
-            >> normalDirections_
-            >> edgeNormals_
-            >> featurePointNormals_
-            >> featurePointEdges_
-            >> regionEdges_;
-
-        close();
-
-        {
-            // Calculate edgeDirections
-
-            const edgeList& eds(edges());
-
-            const pointField& pts(points());
-
-            edgeDirections_.setSize(eds.size());
-
-            forAll(eds, eI)
-            {
-                edgeDirections_[eI] = eds[eI].vec(pts);
-            }
-
-            edgeDirections_ /= (mag(edgeDirections_) + SMALL);
-        }
-    }
-
-    if (debug)
-    {
-        Pout<< "extendedFeatureEdgeMesh::extendedFeatureEdgeMesh :"
-            << " constructed from IOobject :"
-            << " points:" << points().size()
-            << " edges:" << edges().size()
-            << endl;
-    }
-}
+{}
 
 
-Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh
+Foam::extendedEdgeMesh::extendedEdgeMesh
 (
-    const IOobject& io,
-    const extendedFeatureEdgeMesh& fem
+    const extendedEdgeMesh& fem
 )
 :
-    regIOobject(io),
     edgeMesh(fem),
     concaveStart_(fem.concaveStart()),
     mixedStart_(fem.mixedStart()),
@@ -229,14 +313,18 @@ Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh
 {}
 
 
-Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh
+Foam::extendedEdgeMesh::extendedEdgeMesh(Istream& is)
+{
+    is >> *this;
+}
+
+
+Foam::extendedEdgeMesh::extendedEdgeMesh
 (
-    const IOobject& io,
     const Xfer<pointField>& pointLst,
     const Xfer<edgeList>& edgeLst
 )
 :
-    regIOobject(io),
     edgeMesh(pointLst, edgeLst),
     concaveStart_(0),
     mixedStart_(0),
@@ -259,26 +347,12 @@ Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh
 {}
 
 
-Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh
+Foam::extendedEdgeMesh::extendedEdgeMesh
 (
     const surfaceFeatures& sFeat,
-    const objectRegistry& obr,
-    const fileName& sFeatFileName,
     const boolList& surfBaffleRegions
 )
 :
-    regIOobject
-    (
-        IOobject
-        (
-            sFeatFileName,
-            obr.time().constant(),
-            "extendedFeatureEdgeMesh",
-            obr,
-            IOobject::NO_READ,
-            IOobject::NO_WRITE
-        )
-    ),
     edgeMesh(pointField(0), edgeList(0)),
     concaveStart_(-1),
     mixedStart_(-1),
@@ -352,16 +426,14 @@ Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh
 }
 
 
-Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh
+Foam::extendedEdgeMesh::extendedEdgeMesh
 (
-    const IOobject& io,
     const PrimitivePatch<face, List, pointField, point>& surf,
     const labelList& featureEdges,
     const labelList& regionFeatureEdges,
     const labelList& featurePoints
 )
 :
-    regIOobject(io),
     edgeMesh(pointField(0), edgeList(0)),
     concaveStart_(-1),
     mixedStart_(-1),
@@ -392,9 +464,8 @@ Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh
 }
 
 
-Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh
+Foam::extendedEdgeMesh::extendedEdgeMesh
 (
-    const IOobject& io,
     const pointField& pts,
     const edgeList& eds,
     label concaveStart,
@@ -414,7 +485,6 @@ Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh
     const labelList& regionEdges
 )
 :
-    regIOobject(io),
     edgeMesh(pts, eds),
     concaveStart_(concaveStart),
     mixedStart_(mixedStart),
@@ -437,108 +507,99 @@ Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh
 {}
 
 
-// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
-
-Foam::extendedFeatureEdgeMesh::~extendedFeatureEdgeMesh()
-{}
-
+Foam::extendedEdgeMesh::extendedEdgeMesh
+(
+    const fileName& name,
+    const word& ext
+)
+:
+    edgeMesh(pointField(0), edgeList(0)),
+    concaveStart_(0),
+    mixedStart_(0),
+    nonFeatureStart_(0),
+    internalStart_(0),
+    flatStart_(0),
+    openStart_(0),
+    multipleStart_(0),
+    normals_(0),
+    normalVolumeTypes_(0),
+    edgeDirections_(0),
+    normalDirections_(0),
+    edgeNormals_(0),
+    featurePointNormals_(0),
+    featurePointEdges_(0),
+    regionEdges_(0),
+    pointTree_(),
+    edgeTree_(),
+    edgeTreesByType_()
+{
+    read(name, ext);
+}
 
-// * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * * //
 
-Foam::extendedFeatureEdgeMesh::pointStatus
-Foam::extendedFeatureEdgeMesh::classifyFeaturePoint
-(
-    label ptI
-) const
+Foam::extendedEdgeMesh::extendedEdgeMesh(const fileName& name)
+:
+    edgeMesh(pointField(0), edgeList(0)),
+    concaveStart_(0),
+    mixedStart_(0),
+    nonFeatureStart_(0),
+    internalStart_(0),
+    flatStart_(0),
+    openStart_(0),
+    multipleStart_(0),
+    normals_(0),
+    normalVolumeTypes_(0),
+    edgeDirections_(0),
+    normalDirections_(0),
+    edgeNormals_(0),
+    featurePointNormals_(0),
+    featurePointEdges_(0),
+    regionEdges_(0),
+    pointTree_(),
+    edgeTree_(),
+    edgeTreesByType_()
 {
-    labelList ptEds(pointEdges()[ptI]);
+    read(name);
+}
 
-    label nPtEds = ptEds.size();
-    label nExternal = 0;
-    label nInternal = 0;
 
-    if (nPtEds == 0)
-    {
-        // There are no edges attached to the point, this is a problem
-        return NONFEATURE;
-    }
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
 
-    forAll(ptEds, i)
-    {
-        edgeStatus edStat = getEdgeStatus(ptEds[i]);
+Foam::extendedEdgeMesh::~extendedEdgeMesh()
+{}
 
-        if (edStat == EXTERNAL)
-        {
-            nExternal++;
-        }
-        else if (edStat == INTERNAL)
-        {
-            nInternal++;
-        }
-    }
 
-    if (nExternal == nPtEds)
-    {
-        return CONVEX;
-    }
-    else if (nInternal == nPtEds)
+// * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
+
+bool Foam::extendedEdgeMesh::read(const fileName& name)
+{
+    word ext = name.ext();
+    if (ext == "gz")
     {
-        return CONCAVE;
+        fileName unzipName = name.lessExt();
+        return read(unzipName, unzipName.ext());
     }
     else
     {
-        return MIXED;
+        return read(name, ext);
     }
 }
 
 
-Foam::extendedFeatureEdgeMesh::edgeStatus
-Foam::extendedFeatureEdgeMesh::classifyEdge
+// Read from file in given format
+bool Foam::extendedEdgeMesh::read
 (
-    const List<vector>& norms,
-    const labelList& edNorms,
-    const vector& fC0tofC1
+    const fileName& name,
+    const word& ext
 )
 {
-    label nEdNorms = edNorms.size();
-
-    if (nEdNorms == 1)
-    {
-        return OPEN;
-    }
-    else if (nEdNorms == 2)
-    {
-        const vector& n0(norms[edNorms[0]]);
-        const vector& n1(norms[edNorms[1]]);
-
-        if ((n0 & n1) > cosNormalAngleTol_)
-        {
-            return FLAT;
-        }
-        else if ((fC0tofC1 & n0) > 0.0)
-        {
-            return INTERNAL;
-        }
-        else
-        {
-            return EXTERNAL;
-        }
-    }
-    else if (nEdNorms > 2)
-    {
-        return MULTIPLE;
-    }
-    else
-    {
-        // There is a problem - the edge has no normals
-        return NONE;
-    }
+    // read via selector mechanism
+    transfer(New(name, ext)());
+    return true;
 }
 
 
-// * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
-
-void Foam::extendedFeatureEdgeMesh::nearestFeaturePoint
+void Foam::extendedEdgeMesh::nearestFeaturePoint
 (
     const point& sample,
     scalar searchDistSqr,
@@ -553,7 +614,7 @@ void Foam::extendedFeatureEdgeMesh::nearestFeaturePoint
 }
 
 
-void Foam::extendedFeatureEdgeMesh::nearestFeatureEdge
+void Foam::extendedEdgeMesh::nearestFeatureEdge
 (
     const point& sample,
     scalar searchDistSqr,
@@ -568,7 +629,7 @@ void Foam::extendedFeatureEdgeMesh::nearestFeatureEdge
 }
 
 
-void Foam::extendedFeatureEdgeMesh::nearestFeatureEdge
+void Foam::extendedEdgeMesh::nearestFeatureEdge
 (
     const pointField& samples,
     const scalarField& searchDistSqr,
@@ -589,7 +650,7 @@ void Foam::extendedFeatureEdgeMesh::nearestFeatureEdge
 }
 
 
-void Foam::extendedFeatureEdgeMesh::nearestFeatureEdgeByType
+void Foam::extendedEdgeMesh::nearestFeatureEdgeByType
 (
     const point& sample,
     const scalarField& searchDistSqr,
@@ -625,7 +686,7 @@ void Foam::extendedFeatureEdgeMesh::nearestFeatureEdgeByType
 }
 
 
-void Foam::extendedFeatureEdgeMesh::allNearestFeaturePoints
+void Foam::extendedEdgeMesh::allNearestFeaturePoints
 (
     const point& sample,
     scalar searchRadiusSqr,
@@ -656,7 +717,7 @@ void Foam::extendedFeatureEdgeMesh::allNearestFeaturePoints
 }
 
 
-void Foam::extendedFeatureEdgeMesh::allNearestFeatureEdges
+void Foam::extendedEdgeMesh::allNearestFeatureEdges
 (
     const point& sample,
     const scalar searchRadiusSqr,
@@ -713,7 +774,7 @@ void Foam::extendedFeatureEdgeMesh::allNearestFeatureEdges
 
 
 const Foam::indexedOctree<Foam::treeDataPoint>&
-Foam::extendedFeatureEdgeMesh::pointTree() const
+Foam::extendedEdgeMesh::pointTree() const
 {
     if (pointTree_.empty())
     {
@@ -753,7 +814,7 @@ Foam::extendedFeatureEdgeMesh::pointTree() const
 
 
 const Foam::indexedOctree<Foam::treeDataEdge>&
-Foam::extendedFeatureEdgeMesh::edgeTree() const
+Foam::extendedEdgeMesh::edgeTree() const
 {
     if (edgeTree_.empty())
     {
@@ -795,7 +856,7 @@ Foam::extendedFeatureEdgeMesh::edgeTree() const
 
 
 const Foam::PtrList<Foam::indexedOctree<Foam::treeDataEdge> >&
-Foam::extendedFeatureEdgeMesh::edgeTreesByType() const
+Foam::extendedEdgeMesh::edgeTreesByType() const
 {
     if (edgeTreesByType_.size() == 0)
     {
@@ -859,7 +920,62 @@ Foam::extendedFeatureEdgeMesh::edgeTreesByType() const
 }
 
 
-void Foam::extendedFeatureEdgeMesh::add(const extendedFeatureEdgeMesh& fem)
+void Foam::extendedEdgeMesh::transfer(extendedEdgeMesh& mesh)
+{
+    edgeMesh::transfer(mesh);
+
+    concaveStart_ = mesh.concaveStart_;
+    mixedStart_ = mesh.mixedStart_;
+    nonFeatureStart_ = mesh.nonFeatureStart_;
+    internalStart_ = mesh.internalStart_;
+    flatStart_ = mesh.flatStart_;
+    openStart_ = mesh.openStart_;
+    multipleStart_ = mesh.multipleStart_;
+    normals_.transfer(mesh.normals_);
+    normalVolumeTypes_.transfer(mesh.normalVolumeTypes_);
+    edgeDirections_.transfer(mesh.edgeDirections_);
+    normalDirections_.transfer(mesh.normalDirections_);
+    edgeNormals_.transfer(mesh.edgeNormals_);
+    featurePointNormals_.transfer(mesh.featurePointNormals_);
+    featurePointEdges_.transfer(mesh.featurePointEdges_);
+    regionEdges_.transfer(mesh.regionEdges_);
+    pointTree_ = mesh.pointTree_;
+    edgeTree_ = mesh.edgeTree_;
+    edgeTreesByType_.transfer(mesh.edgeTreesByType_);
+}
+
+
+Foam::Xfer<Foam::extendedEdgeMesh> Foam::extendedEdgeMesh::xfer()
+{
+    return xferMoveTo<extendedEdgeMesh, extendedEdgeMesh>(*this);
+}
+
+
+void Foam::extendedEdgeMesh::clear()
+{
+    edgeMesh::clear();
+    concaveStart_ = 0;
+    mixedStart_ = 0;
+    nonFeatureStart_ = 0;
+    internalStart_ = 0;
+    flatStart_ = 0;
+    openStart_ = 0;
+    multipleStart_ = 0;
+    normals_.clear();
+    normalVolumeTypes_.clear();
+    edgeDirections_.clear();
+    normalDirections_.clear();
+    edgeNormals_.clear();
+    featurePointNormals_.clear();
+    featurePointEdges_.clear();
+    regionEdges_.clear();
+    pointTree_.clear();
+    edgeTree_.clear();
+    edgeTreesByType_.clear();
+}
+
+
+void Foam::extendedEdgeMesh::add(const extendedEdgeMesh& fem)
 {
     // Points
     // ~~~~~~
@@ -1107,7 +1223,7 @@ void Foam::extendedFeatureEdgeMesh::add(const extendedFeatureEdgeMesh& fem)
 }
 
 
-void Foam::extendedFeatureEdgeMesh::flipNormals()
+void Foam::extendedEdgeMesh::flipNormals()
 {
     // Points
     // ~~~~~~
@@ -1213,50 +1329,47 @@ void Foam::extendedFeatureEdgeMesh::flipNormals()
     edgeTree_.clear();
     edgeTreesByType_.clear();
 }
-//XXXXX
 
-void Foam::extendedFeatureEdgeMesh::writeObj
+
+void Foam::extendedEdgeMesh::writeObj
 (
     const fileName& prefix
 ) const
 {
-    Info<< nl << "Writing extendedFeatureEdgeMesh components to " << prefix
+    Info<< nl << "Writing extendedEdgeMesh components to " << prefix
         << endl;
 
-    label verti = 0;
-
     edgeMesh::write(prefix + "_edgeMesh.obj");
 
-    OFstream convexFtPtStr(prefix + "_convexFeaturePts.obj");
+    OBJstream convexFtPtStr(prefix + "_convexFeaturePts.obj");
     Info<< "Writing convex feature points to " << convexFtPtStr.name() << endl;
 
     for(label i = 0; i < concaveStart_; i++)
     {
-        meshTools::writeOBJ(convexFtPtStr, points()[i]);
+        convexFtPtStr.write(points()[i]);
     }
 
-    OFstream concaveFtPtStr(prefix + "_concaveFeaturePts.obj");
+    OBJstream concaveFtPtStr(prefix + "_concaveFeaturePts.obj");
     Info<< "Writing concave feature points to "
         << concaveFtPtStr.name() << endl;
 
     for(label i = concaveStart_; i < mixedStart_; i++)
     {
-        meshTools::writeOBJ(concaveFtPtStr, points()[i]);
+        convexFtPtStr.write(points()[i]);
     }
 
-    OFstream mixedFtPtStr(prefix + "_mixedFeaturePts.obj");
+    OBJstream mixedFtPtStr(prefix + "_mixedFeaturePts.obj");
     Info<< "Writing mixed feature points to " << mixedFtPtStr.name() << endl;
 
     for(label i = mixedStart_; i < nonFeatureStart_; i++)
     {
-        meshTools::writeOBJ(mixedFtPtStr, points()[i]);
+        mixedFtPtStr.write(points()[i]);
     }
 
-    OFstream mixedFtPtStructureStr(prefix + "_mixedFeaturePtsStructure.obj");
+    OBJstream mixedFtPtStructureStr(prefix + "_mixedFeaturePtsStructure.obj");
     Info<< "Writing mixed feature point structure to "
         << mixedFtPtStructureStr.name() << endl;
 
-    verti = 0;
     for(label i = mixedStart_; i < nonFeatureStart_; i++)
     {
         const labelList& ptEds = pointEdges()[i];
@@ -1264,92 +1377,69 @@ void Foam::extendedFeatureEdgeMesh::writeObj
         forAll(ptEds, j)
         {
             const edge& e = edges()[ptEds[j]];
-
-            meshTools::writeOBJ(mixedFtPtStructureStr, points()[e[0]]); verti++;
-            meshTools::writeOBJ(mixedFtPtStructureStr, points()[e[1]]); verti++;
-            mixedFtPtStructureStr << "l " << verti-1 << ' ' << verti << endl;
+            mixedFtPtStructureStr.write
+            (
+                linePointRef(points()[e[0]],
+                points()[e[1]])
+            );
         }
     }
 
-    OFstream externalStr(prefix + "_externalEdges.obj");
+    OBJstream externalStr(prefix + "_externalEdges.obj");
     Info<< "Writing external edges to " << externalStr.name() << endl;
 
-    verti = 0;
     for (label i = externalStart_; i < internalStart_; i++)
     {
         const edge& e = edges()[i];
-
-        meshTools::writeOBJ(externalStr, points()[e[0]]); verti++;
-        meshTools::writeOBJ(externalStr, points()[e[1]]); verti++;
-        externalStr << "l " << verti-1 << ' ' << verti << endl;
+        externalStr.write(linePointRef(points()[e[0]], points()[e[1]]));
     }
 
-    OFstream internalStr(prefix + "_internalEdges.obj");
+    OBJstream internalStr(prefix + "_internalEdges.obj");
     Info<< "Writing internal edges to " << internalStr.name() << endl;
 
-    verti = 0;
     for (label i = internalStart_; i < flatStart_; i++)
     {
         const edge& e = edges()[i];
-
-        meshTools::writeOBJ(internalStr, points()[e[0]]); verti++;
-        meshTools::writeOBJ(internalStr, points()[e[1]]); verti++;
-        internalStr << "l " << verti-1 << ' ' << verti << endl;
+        internalStr.write(linePointRef(points()[e[0]], points()[e[1]]));
     }
 
-    OFstream flatStr(prefix + "_flatEdges.obj");
+    OBJstream flatStr(prefix + "_flatEdges.obj");
     Info<< "Writing flat edges to " << flatStr.name() << endl;
 
-    verti = 0;
     for (label i = flatStart_; i < openStart_; i++)
     {
         const edge& e = edges()[i];
-
-        meshTools::writeOBJ(flatStr, points()[e[0]]); verti++;
-        meshTools::writeOBJ(flatStr, points()[e[1]]); verti++;
-        flatStr << "l " << verti-1 << ' ' << verti << endl;
+        flatStr.write(linePointRef(points()[e[0]], points()[e[1]]));
     }
 
-    OFstream openStr(prefix + "_openEdges.obj");
+    OBJstream openStr(prefix + "_openEdges.obj");
     Info<< "Writing open edges to " << openStr.name() << endl;
 
-    verti = 0;
     for (label i = openStart_; i < multipleStart_; i++)
     {
         const edge& e = edges()[i];
-
-        meshTools::writeOBJ(openStr, points()[e[0]]); verti++;
-        meshTools::writeOBJ(openStr, points()[e[1]]); verti++;
-        openStr << "l " << verti-1 << ' ' << verti << endl;
+        openStr.write(linePointRef(points()[e[0]], points()[e[1]]));
     }
 
-    OFstream multipleStr(prefix + "_multipleEdges.obj");
+    OBJstream multipleStr(prefix + "_multipleEdges.obj");
     Info<< "Writing multiple edges to " << multipleStr.name() << endl;
 
-    verti = 0;
     for (label i = multipleStart_; i < edges().size(); i++)
     {
         const edge& e = edges()[i];
-
-        meshTools::writeOBJ(multipleStr, points()[e[0]]); verti++;
-        meshTools::writeOBJ(multipleStr, points()[e[1]]); verti++;
-        multipleStr << "l " << verti-1 << ' ' << verti << endl;
+        multipleStr.write(linePointRef(points()[e[0]], points()[e[1]]));
     }
 
-    OFstream regionStr(prefix + "_regionEdges.obj");
+    OBJstream regionStr(prefix + "_regionEdges.obj");
     Info<< "Writing region edges to " << regionStr.name() << endl;
 
-    verti = 0;
     forAll(regionEdges_, i)
     {
         const edge& e = edges()[regionEdges_[i]];
-
-        meshTools::writeOBJ(regionStr, points()[e[0]]); verti++;
-        meshTools::writeOBJ(regionStr, points()[e[1]]); verti++;
-        regionStr << "l " << verti-1 << ' ' << verti << endl;
+        regionStr.write(linePointRef(points()[e[0]], points()[e[1]]));
     }
 
-    OFstream edgeDirsStr(prefix + "_edgeDirections.obj");
+    OBJstream edgeDirsStr(prefix + "_edgeDirections.obj");
     Info<< "Writing edge directions to " << edgeDirsStr.name() << endl;
 
     forAll(edgeDirections_, i)
@@ -1357,61 +1447,52 @@ void Foam::extendedFeatureEdgeMesh::writeObj
         const vector& eVec = edgeDirections_[i];
         const edge& e = edges()[i];
 
-        meshTools::writeOBJ
+        edgeDirsStr.write
         (
-            edgeDirsStr,
-            points()[e.start()],
-            eVec + points()[e.start()]
+            linePointRef(points()[e.start()], eVec + points()[e.start()])
         );
     }
 }
 
 
-bool Foam::extendedFeatureEdgeMesh::writeData(Ostream& os) const
+void Foam::extendedEdgeMesh::writeStats(Ostream& os) const
 {
-    os  << "// points" << nl
-        << points() << nl
-        << "// edges" << nl
-        << edges() << nl
-        << "// concaveStart mixedStart nonFeatureStart" << nl
-        << concaveStart_ << token::SPACE
-        << mixedStart_ << token::SPACE
-        << nonFeatureStart_ << nl
-        << "// internalStart flatStart openStart multipleStart" << nl
-        << internalStart_ << token::SPACE
-        << flatStart_ << token::SPACE
-        << openStart_ << token::SPACE
-        << multipleStart_ << nl
-        << "// normals" << nl
-        << normals_ << nl
-        << "// normal volume types" << nl
-        << normalVolumeTypes_ << nl
-        << "// normalDirections" << nl
-        << normalDirections_ << nl
-        << "// edgeNormals" << nl
-        << edgeNormals_ << nl
-        << "// featurePointNormals" << nl
-        << featurePointNormals_ << nl
-        << "// featurePointEdges" << nl
-        << featurePointEdges_ << nl
-        << "// regionEdges" << nl
-        << regionEdges_
-        << endl;
-
-    return os.good();
+    edgeMesh::writeStats(os);
+
+    os  << indent << "point offsets :" << nl;
+    os  << incrIndent;
+    os  << indent << "convex feature points      : " << convexStart_ << nl;
+    os  << indent << "concave feature points     : " << concaveStart_ << nl;
+    os  << indent << "mixed feature points       : " << mixedStart_ << nl;
+    os  << indent << "other (non-feature) points : " << nonFeatureStart_ << nl;
+    os  << decrIndent;
+
+    os  << indent << "edge offsets :" << nl;
+    os  << incrIndent;
+    os  << indent << "external (convex angle) edges  : " << externalStart_
+        << nl;
+    os  << indent << "internal (concave angle) edges : " << internalStart_
+        << nl;
+    os  << indent << "flat region edges              : " << flatStart_ << nl;
+    os  << indent << "open edges                     : " << openStart_ << nl;
+    os  << indent << "multiply connected edges       : " << multipleStart_
+        << nl;
+    os  << decrIndent;
 }
 
 
+// * * * * * * * * * * * * * * * IOstream Operators  * * * * * * * * * * * * //
+
 Foam::Istream& Foam::operator>>
 (
     Istream& is,
-    Foam::extendedFeatureEdgeMesh::sideVolumeType& vt
+    Foam::extendedEdgeMesh::sideVolumeType& vt
 )
 {
     label type;
     is  >> type;
 
-    vt = static_cast<Foam::extendedFeatureEdgeMesh::sideVolumeType>(type);
+    vt = static_cast<Foam::extendedEdgeMesh::sideVolumeType>(type);
 
     // Check state of Istream
     is.check("operator>>(Istream&, sideVolumeType&)");
@@ -1423,7 +1504,7 @@ Foam::Istream& Foam::operator>>
 Foam::Ostream& Foam::operator<<
 (
     Ostream& os,
-    const Foam::extendedFeatureEdgeMesh::sideVolumeType& vt
+    const Foam::extendedEdgeMesh::sideVolumeType& vt
 )
 {
     os  << static_cast<label>(vt);
@@ -1432,4 +1513,69 @@ Foam::Ostream& Foam::operator<<
 }
 
 
+Foam::Ostream& Foam::operator<<(Ostream& os, const extendedEdgeMesh& em)
+{
+    //fileFormats::extendedEdgeMeshFormat::write(os, em.points_, em.edges_);
+    os  << "// points" << nl
+        << em.points() << nl
+        << "// edges" << nl
+        << em.edges() << nl
+        << "// concaveStart mixedStart nonFeatureStart" << nl
+        << em.concaveStart_ << token::SPACE
+        << em.mixedStart_ << token::SPACE
+        << em.nonFeatureStart_ << nl
+        << "// internalStart flatStart openStart multipleStart" << nl
+        << em.internalStart_ << token::SPACE
+        << em.flatStart_ << token::SPACE
+        << em.openStart_ << token::SPACE
+        << em.multipleStart_ << nl
+        << "// normals" << nl
+        << em.normals_ << nl
+        << "// normal volume types" << nl
+        << em.normalVolumeTypes_ << nl
+        << "// normalDirections" << nl
+        << em.normalDirections_ << nl
+        << "// edgeNormals" << nl
+        << em.edgeNormals_ << nl
+        << "// featurePointNormals" << nl
+        << em.featurePointNormals_ << nl
+        << "// featurePointEdges" << nl
+        << em.featurePointEdges_ << nl
+        << "// regionEdges" << nl
+        << em.regionEdges_
+        << endl;
+
+    // Check state of Ostream
+    os.check("Ostream& operator<<(Ostream&, const extendedEdgeMesh&)");
+
+    return os;
+}
+
+
+Foam::Istream& Foam::operator>>(Istream& is, extendedEdgeMesh& em)
+{
+    //fileFormats::extendedEdgeMeshFormat::read(is, em.points_, em.edges_);
+    is  >> static_cast<edgeMesh&>(em)
+        >> em.concaveStart_
+        >> em.mixedStart_
+        >> em.nonFeatureStart_
+        >> em.internalStart_
+        >> em.flatStart_
+        >> em.openStart_
+        >> em.multipleStart_
+        >> em.normals_
+        >> em.normalVolumeTypes_
+        >> em.normalDirections_
+        >> em.edgeNormals_
+        >> em.featurePointNormals_
+        >> em.featurePointEdges_
+        >> em.regionEdges_;
+
+    // Check state of Istream
+    is.check("Istream& operator>>(Istream&, extendedEdgeMesh&)");
+
+    return is;
+}
+
+
 // ************************************************************************* //
diff --git a/src/edgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.H b/src/edgeMesh/extendedEdgeMesh/extendedEdgeMesh.H
similarity index 82%
rename from src/edgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.H
rename to src/edgeMesh/extendedEdgeMesh/extendedEdgeMesh.H
index fdeeeb8dd0a9cf67ec5709ca5e352fd20c9b7f2d..58e2ba8cabe922298fa2ef03f171861d60653e34 100644
--- a/src/edgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.H
+++ b/src/edgeMesh/extendedEdgeMesh/extendedEdgeMesh.H
@@ -22,7 +22,7 @@ License
     along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
 
 Class
-    Foam::extendedFeatureEdgeMesh
+    Foam::extendedEdgeMesh
 
 Description
 
@@ -47,16 +47,16 @@ Description
     are stored.
 
 SourceFiles
-    extendedFeatureEdgeMeshI.H
-    extendedFeatureEdgeMesh.C
+    extendedEdgeMeshI.H
+    extendedEdgeMesh.C
+    extendedEdgeMeshNew.C
 
 \*---------------------------------------------------------------------------*/
 
-#ifndef extendedFeatureEdgeMesh_H
-#define extendedFeatureEdgeMesh_H
+#ifndef extendedEdgeMesh_H
+#define extendedEdgeMesh_H
 
 #include "edgeMesh.H"
-#include "regIOobject.H"
 #include "indexedOctree.H"
 #include "treeDataEdge.H"
 #include "treeDataPoint.H"
@@ -70,20 +70,24 @@ namespace Foam
 class surfaceFeatures;
 class objectRegistry;
 
+// Forward declaration of friend functions and operators
+class extendedEdgeMesh;
+Istream& operator>>(Istream&, extendedEdgeMesh&);
+Ostream& operator<<(Ostream&, const extendedEdgeMesh&);
+
 /*---------------------------------------------------------------------------*\
-                       Class extendedFeatureEdgeMesh Declaration
+                       Class extendedEdgeMesh Declaration
 \*---------------------------------------------------------------------------*/
 
-class extendedFeatureEdgeMesh
+class extendedEdgeMesh
 :
-    public regIOobject,
     public edgeMesh
 {
 
 public:
 
     //- Runtime type information
-    TypeName("extendedFeatureEdgeMesh");
+    TypeName("extendedEdgeMesh");
 
     enum pointStatus
     {
@@ -123,7 +127,7 @@ public:
     static scalar cosNormalAngleTol_;
 
 
-private:
+protected:
 
     // Static data
 
@@ -221,23 +225,39 @@ public:
         //- Number of possible feature edge types (i.e. number of slices)
         static label nEdgeTypes;
 
+        //- Can we read this file format?
+        static bool canRead(const fileName&, const bool verbose=false);
+
+        //- Can we read this file format?
+        static bool canReadType(const word& ext, const bool verbose=false);
+
+        //- Can we write this file format type?
+        static bool canWriteType(const word& ext, const bool verbose=false);
+
+        static wordHashSet readTypes();
+        static wordHashSet writeTypes();
+
 
     // Constructors
 
-        //- Construct (read) given an IOobject
-        extendedFeatureEdgeMesh(const IOobject&);
+        //- Construct null
+        extendedEdgeMesh();
 
         //- Construct as copy
-        explicit extendedFeatureEdgeMesh
-        (
-            const IOobject&,
-            const extendedFeatureEdgeMesh&
-        );
+        explicit extendedEdgeMesh(const extendedEdgeMesh&);
+
+        //- Construct from file name (uses extension to determine type)
+        extendedEdgeMesh(const fileName&);
+
+        //- Construct from file name (uses extension to determine type)
+        extendedEdgeMesh(const fileName&, const word& ext);
+
+        //- Construct from Istream
+        extendedEdgeMesh(Istream&);
 
         //- Construct by transferring components (points, edges)
-        extendedFeatureEdgeMesh
+        extendedEdgeMesh
         (
-            const IOobject&,
             const Xfer<pointField>&,
             const Xfer<edgeList>&
         );
@@ -246,18 +266,15 @@ public:
         //  (surfaceFeatures), an objectRegistry and a
         //  fileName to write to.
         //  Extracts, classifies and reorders the data from surfaceFeatures.
-        extendedFeatureEdgeMesh
+        extendedEdgeMesh
         (
             const surfaceFeatures& sFeat,
-            const objectRegistry& obr,
-            const fileName& sFeatFileName,
             const boolList& surfBaffleRegions
         );
 
         //- Construct from PrimitivePatch
-        extendedFeatureEdgeMesh
+        extendedEdgeMesh
         (
-            const IOobject&,
             const PrimitivePatch<face, List, pointField, point>& surf,
             const labelList& featureEdges,
             const labelList& regionFeatureEdges,
@@ -265,9 +282,8 @@ public:
         );
 
         //- Construct from all components
-        extendedFeatureEdgeMesh
+        extendedEdgeMesh
         (
-            const IOobject& io,
             const pointField& pts,
             const edgeList& eds,
             label concaveStart,
@@ -288,8 +304,35 @@ public:
         );
 
 
+    // Declare run-time constructor selection table
+
+        declareRunTimeSelectionTable
+        (
+            autoPtr,
+            extendedEdgeMesh,
+            fileExtension,
+            (
+                const fileName& name
+            ),
+            (name)
+        );
+
+
+    // Selectors
+
+        //- Select constructed from filename (explicit extension)
+        static autoPtr<extendedEdgeMesh> New
+        (
+            const fileName&,
+            const word& ext
+        );
+
+        //- Select constructed from filename (implicit extension)
+        static autoPtr<extendedEdgeMesh> New(const fileName&);
+
+
     //- Destructor
-    ~extendedFeatureEdgeMesh();
+    ~extendedEdgeMesh();
 
 
     // Member Functions
@@ -442,24 +485,39 @@ public:
 
         // Edit
 
-            //- Add extendedFeatureEdgeMesh. No filtering of duplicates.
-            void add(const extendedFeatureEdgeMesh&);
+            //- Transfer the contents of the argument and annul the argument
+            void transfer(extendedEdgeMesh&);
+
+            //- Transfer contents to the Xfer container
+            Xfer<extendedEdgeMesh > xfer();
+
+            //- Clear all storage
+            virtual void clear();
+
+            //- Add extendedEdgeMesh. No filtering of duplicates.
+            void add(const extendedEdgeMesh&);
 
             //- Flip normals. All concave become convex, all internal external
             //  etc.
             void flipNormals();
 
 
+        // Read
+
+            //- Read from file. Chooses reader based on explicit extension
+            bool read(const fileName&, const word& ext);
+
+            //- Read from file. Chooses reader based on detected extension
+            virtual bool read(const fileName&);
+
+
         // Write
 
-            //- Write all components of the extendedFeatureEdgeMesh as obj files
+            //- Write all components of the extendedEdgeMesh as obj files
             void writeObj(const fileName& prefix) const;
 
-            //- Give precedence to the regIOobject write
-            using regIOobject::write;
-
-            //- WriteData function required for regIOobject write operation
-            virtual bool writeData(Ostream&) const;
+            //- Dump some information
+            virtual void writeStats(Ostream& os) const;
 
             friend Istream& operator>>(Istream& is, sideVolumeType& vt);
             friend Ostream& operator<<(Ostream& os, const sideVolumeType& vt);
@@ -473,6 +531,12 @@ public:
             const labelList& edNorms,
             const vector& fC0tofC1
         );
+
+
+        // Ostream Operator
+
+            friend Ostream& operator<<(Ostream&, const extendedEdgeMesh&);
+            friend Istream& operator>>(Istream&, extendedEdgeMesh&);
 };
 
 
@@ -482,10 +546,10 @@ public:
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-#include "extendedFeatureEdgeMeshI.H"
+#include "extendedEdgeMeshI.H"
 
 #ifdef NoRepository
-#   include "extendedFeatureEdgeMeshTemplates.C"
+#   include "extendedEdgeMeshTemplates.C"
 #endif
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
diff --git a/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshFormats/extendedEdgeMeshFormat/extendedEdgeMeshFormat.C b/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshFormats/extendedEdgeMeshFormat/extendedEdgeMeshFormat.C
new file mode 100644
index 0000000000000000000000000000000000000000..a8ee72c4345fb6166cdef60ed2728a666716006b
--- /dev/null
+++ b/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshFormats/extendedEdgeMeshFormat/extendedEdgeMeshFormat.C
@@ -0,0 +1,103 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "extendedEdgeMeshFormat.H"
+#include "edgeMeshFormat.H"
+#include "IFstream.H"
+#include "Time.H"
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::fileFormats::extendedEdgeMeshFormat::extendedEdgeMeshFormat
+(
+    const fileName& filename
+)
+{
+    read(filename);
+}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+bool Foam::fileFormats::extendedEdgeMeshFormat::read
+(
+    const fileName& filename
+)
+{
+    clear();
+
+    fileName dir = filename.path();
+    fileName caseName = dir.name();
+    fileName rootPath = dir.path();
+
+    // Construct dummy time to use as an objectRegistry
+    Time dummyTime
+    (
+        ".",        //rootPath,
+        ".",        //caseName,
+        "system",   //systemName,
+        "constant", //constantName,
+        false       //enableFunctionObjects
+    );
+
+    // Construct IOobject to re-use the headerOk & readHeader
+    // (so we can read ascii and binary)
+    IOobject io
+    (
+        filename,
+        dummyTime,
+        IOobject::NO_READ,
+        IOobject::NO_WRITE,
+        false
+    );
+
+    if (!io.headerOk())
+    {
+        FatalErrorIn
+        ("fileFormats::extendedEdgeMeshFormat::read(const fileName&)")
+            << "Cannot read file " << filename
+            << exit(FatalError);
+    }
+
+    autoPtr<IFstream> isPtr(new IFstream(io.filePath()));
+    bool ok = false;
+    if (isPtr().good())
+    {
+        Istream& is = isPtr();
+        ok = io.readHeader(is);
+
+        if (ok)
+        {
+            // Use extendedEdgeMesh IO
+            is >> *this;
+            ok = is.good();
+        }
+    }
+
+    return ok;
+}
+
+
+// ************************************************************************* //
diff --git a/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshFormats/extendedEdgeMeshFormat/extendedEdgeMeshFormat.H b/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshFormats/extendedEdgeMeshFormat/extendedEdgeMeshFormat.H
new file mode 100644
index 0000000000000000000000000000000000000000..0bd618e07319b980cb4ca475307ab84af79a4bc6
--- /dev/null
+++ b/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshFormats/extendedEdgeMeshFormat/extendedEdgeMeshFormat.H
@@ -0,0 +1,95 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::fileFormats::extendedEdgeMeshFormat
+
+Description
+    Provide a means of reading/writing the single-file OpenFOAM
+    extendedEdgeMesh format
+
+SourceFiles
+    extendedEdgeMeshFormat.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef extendedEdgeMeshFormat_H
+#define extendedEdgeMeshFormat_H
+
+#include "extendedEdgeMesh.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace fileFormats
+{
+
+/*---------------------------------------------------------------------------*\
+                        Class extendedEdgeMeshFormat Declaration
+\*---------------------------------------------------------------------------*/
+
+class extendedEdgeMeshFormat
+:
+    public extendedEdgeMesh
+{
+    // Private Member Functions
+
+        //- Disallow default bitwise copy construct
+        extendedEdgeMeshFormat(const extendedEdgeMeshFormat&);
+
+        //- Disallow default bitwise assignment
+        void operator=(const extendedEdgeMeshFormat&);
+
+
+public:
+
+    // Constructors
+
+        //- Construct from file name
+        extendedEdgeMeshFormat(const fileName&);
+
+
+    //- Destructor
+    virtual ~extendedEdgeMeshFormat()
+    {}
+
+
+    // Member Functions
+
+        //- Read from file
+        virtual bool read(const fileName&);
+
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace fileFormats
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshFormats/extendedEdgeMeshFormat/extendedEdgeMeshFormatRunTime.C b/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshFormats/extendedEdgeMeshFormat/extendedEdgeMeshFormatRunTime.C
new file mode 100644
index 0000000000000000000000000000000000000000..a98e8ecbe176d62d86b110af02393fb2bac3d0a7
--- /dev/null
+++ b/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshFormats/extendedEdgeMeshFormat/extendedEdgeMeshFormatRunTime.C
@@ -0,0 +1,51 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "extendedEdgeMeshFormat.H"
+#include "extendedEdgeMesh.H"
+
+#include "addToRunTimeSelectionTable.H"
+#include "addToMemberFunctionSelectionTable.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace fileFormats
+{
+
+// read extendedEdgeMesh
+addNamedToRunTimeSelectionTable
+(
+    extendedEdgeMesh,
+    extendedEdgeMeshFormat,
+    fileExtension,
+    extendedFeatureEdgeMesh         // extension
+);
+
+}
+}
+
+// ************************************************************************* //
diff --git a/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshI.H b/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshI.H
new file mode 100644
index 0000000000000000000000000000000000000000..8506fae9e9d867d2228a898b29e993c49c860a56
--- /dev/null
+++ b/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshI.H
@@ -0,0 +1,293 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+inline Foam::label Foam::extendedEdgeMesh::convexStart() const
+{
+    return convexStart_;
+}
+
+
+inline Foam::label Foam::extendedEdgeMesh::concaveStart() const
+{
+    return concaveStart_;
+}
+
+
+inline Foam::label Foam::extendedEdgeMesh::mixedStart() const
+{
+    return mixedStart_;
+}
+
+
+inline Foam::label Foam::extendedEdgeMesh::nonFeatureStart() const
+{
+    return nonFeatureStart_;
+}
+
+
+inline Foam::label Foam::extendedEdgeMesh::externalStart() const
+{
+    return externalStart_;
+}
+
+
+inline Foam::label Foam::extendedEdgeMesh::internalStart() const
+{
+    return internalStart_;
+}
+
+
+inline Foam::label Foam::extendedEdgeMesh::flatStart() const
+{
+    return flatStart_;
+}
+
+
+inline Foam::label Foam::extendedEdgeMesh::openStart() const
+{
+    return openStart_;
+}
+
+
+inline Foam::label Foam::extendedEdgeMesh::multipleStart() const
+{
+    return multipleStart_;
+}
+
+
+inline bool Foam::extendedEdgeMesh::featurePoint(label ptI) const
+{
+    return ptI < nonFeatureStart_;
+}
+
+
+inline const Foam::vectorField& Foam::extendedEdgeMesh::normals() const
+{
+    return normals_;
+}
+
+
+inline const Foam::List<Foam::extendedEdgeMesh::sideVolumeType>&
+Foam::extendedEdgeMesh::normalVolumeTypes() const
+{
+    return normalVolumeTypes_;
+}
+
+
+inline const Foam::vectorField& Foam::extendedEdgeMesh::edgeDirections()
+const
+{
+    return edgeDirections_;
+}
+
+
+inline const Foam::labelListList&
+Foam::extendedEdgeMesh::normalDirections() const
+{
+    return normalDirections_;
+}
+
+
+inline Foam::vector Foam::extendedEdgeMesh::edgeDirection
+(
+    label edgeI,
+    label ptI
+) const
+{
+    const edge& e = edges()[edgeI];
+
+    if (ptI == e.start())
+    {
+        return edgeDirections()[edgeI];
+    }
+    else if (ptI == e.end())
+    {
+        return -edgeDirections()[edgeI];
+    }
+    else
+    {
+        FatalErrorIn("Foam::extendedEdgeMesh::edgeDirection")
+            << "Requested ptI " << ptI << " is not a point on the requested "
+            << "edgeI " << edgeI << ". edgeI start and end: "
+            << e.start() << " " << e.end()
+            << exit(FatalError);
+
+        return vector::zero;
+    }
+}
+
+
+inline const Foam::labelListList& Foam::extendedEdgeMesh::edgeNormals()
+const
+{
+    return edgeNormals_;
+}
+
+
+inline Foam::vectorField Foam::extendedEdgeMesh::edgeNormals
+(
+    const labelList& edgeNormIs
+) const
+{
+    vectorField norms(edgeNormIs.size());
+
+    forAll(edgeNormIs, i)
+    {
+        norms[i] = normals_[edgeNormIs[i]];
+    }
+
+    return norms;
+}
+
+
+inline Foam::vectorField Foam::extendedEdgeMesh::edgeNormals(label edgeI)
+const
+{
+    return edgeNormals(edgeNormals_[edgeI]);
+}
+
+
+inline const Foam::labelListList&
+Foam::extendedEdgeMesh::featurePointNormals() const
+{
+    return featurePointNormals_;
+}
+
+
+inline Foam::vectorField Foam::extendedEdgeMesh::featurePointNormals
+(
+    label ptI
+) const
+{
+    if (!featurePoint(ptI))
+    {
+        WarningIn("vectorField extendedEdgeMesh::featurePointNormals")
+            << "Requesting the normals of a non-feature point. "
+            << "Returned zero length vectorField."
+            << endl;
+
+        return vectorField(0);
+    }
+
+    labelList featPtNormIs(featurePointNormals_[ptI]);
+
+    vectorField norms(featPtNormIs.size());
+
+    forAll(featPtNormIs, i)
+    {
+        norms[i] = normals_[featPtNormIs[i]];
+    }
+
+    return norms;
+}
+
+
+inline const Foam::labelListList&
+Foam::extendedEdgeMesh::featurePointEdges() const
+{
+    return featurePointEdges_;
+}
+
+
+inline const Foam::labelList& Foam::extendedEdgeMesh::regionEdges() const
+{
+    return regionEdges_;
+}
+
+
+inline Foam::extendedEdgeMesh::pointStatus
+Foam::extendedEdgeMesh::getPointStatus(label ptI) const
+{
+    if (ptI < concaveStart_)
+    {
+        return CONVEX;
+    }
+    else if (ptI < mixedStart_)
+    {
+        return CONCAVE;
+    }
+    else if (ptI < nonFeatureStart_)
+    {
+        return MIXED;
+    }
+    else
+    {
+        return NONFEATURE;
+    }
+}
+
+
+inline Foam::extendedEdgeMesh::edgeStatus
+Foam::extendedEdgeMesh::getEdgeStatus(label edgeI) const
+{
+    if (edgeI < internalStart_)
+    {
+        return EXTERNAL;
+    }
+    else if (edgeI < flatStart_)
+    {
+        return INTERNAL;
+    }
+    else if (edgeI < openStart_)
+    {
+        return FLAT;
+    }
+    else if (edgeI < multipleStart_)
+    {
+        return OPEN;
+    }
+    else
+    {
+        return MULTIPLE;
+    }
+}
+
+
+inline Foam::PackedList<2> Foam::extendedEdgeMesh::edgeBaffles
+(
+    label edgeI
+) const
+{
+    const labelList& eNormals = edgeNormals_[edgeI];
+
+    DynamicList<label> edgeBaffles(eNormals.size());
+
+    forAll(eNormals, enI)
+    {
+        const label normI = eNormals[enI];
+
+        if (normalVolumeTypes_[normI])
+        {
+            edgeBaffles.append(normI);
+        }
+    }
+
+    return PackedList<2>(edgeBaffles);
+}
+
+
+// ************************************************************************* //
diff --git a/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshNew.C b/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshNew.C
new file mode 100644
index 0000000000000000000000000000000000000000..5fa8572b6b2789de8e2d59a52b5a5425702fe3aa
--- /dev/null
+++ b/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshNew.C
@@ -0,0 +1,79 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "extendedEdgeMesh.H"
+
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    defineRunTimeSelectionTable(extendedEdgeMesh, fileExtension);
+}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+Foam::autoPtr<Foam::extendedEdgeMesh> Foam::extendedEdgeMesh::New
+(
+    const fileName& name,
+    const word& ext
+)
+{
+    fileExtensionConstructorTable::iterator cstrIter =
+        fileExtensionConstructorTablePtr_->find(ext);
+
+    if (cstrIter == fileExtensionConstructorTablePtr_->end())
+    {
+        FatalErrorIn
+        (
+            "extendedEdgeMesh::New(const fileName&, const word&) : "
+            "constructing extendedEdgeMesh"
+        )   << "Unknown file extension " << ext
+            << " for file " << name << nl << nl
+            << "Valid extensions are :" << nl
+            << fileExtensionConstructorTablePtr_->sortedToc()
+            << exit(FatalError);
+    }
+
+    return autoPtr<extendedEdgeMesh>(cstrIter()(name));
+}
+
+
+Foam::autoPtr<Foam::extendedEdgeMesh> Foam::extendedEdgeMesh::New
+(
+    const fileName& name
+)
+{
+    word ext = name.ext();
+    if (ext == "gz")
+    {
+        ext = name.lessExt().ext();
+    }
+    return New(name, ext);
+}
+
+
+// ************************************************************************* //
diff --git a/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshTemplates.C b/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshTemplates.C
new file mode 100644
index 0000000000000000000000000000000000000000..cdb19b441d836014be3a23f5592ced403f68f93d
--- /dev/null
+++ b/src/edgeMesh/extendedEdgeMesh/extendedEdgeMeshTemplates.C
@@ -0,0 +1,432 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "extendedEdgeMesh.H"
+#include "ListListOps.H"
+#include "unitConversion.H"
+#include "PackedBoolList.H"
+#include "PatchTools.H"
+#include "searchableBox.H"
+
+// * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
+
+template<class Patch>
+void Foam::extendedEdgeMesh::sortPointsAndEdges
+(
+    const Patch& surf,
+    const labelList& featureEdges,
+    const labelList& regionFeatureEdges,// subset of featureEdges: inter-region
+    const labelList& featurePoints
+)
+{
+    const pointField& sFeatLocalPts(surf.localPoints());
+    const edgeList& sFeatEds(surf.edges());
+    const labelListList edgeFaces = PatchTools::sortedEdgeFaces(surf);
+    const vectorField& faceNormals = surf.faceNormals();
+    const labelListList pointEdges = PatchTools::sortedPointEdges(surf);
+
+    // Extract and reorder the data from surfaceFeatures
+
+    // References to the surfaceFeatures data
+
+    // Filling the extendedEdgeMesh with the raw geometrical data.
+
+    label nFeatEds = featureEdges.size();
+    label nFeatPts = featurePoints.size();
+
+    DynamicList<point> tmpPts;
+    edgeList eds(nFeatEds);
+    DynamicList<vector> norms;
+    vectorField edgeDirections(nFeatEds);
+    labelListList edgeNormals(nFeatEds);
+    labelListList normalDirections(nFeatEds);
+    DynamicList<label> regionEdges;
+
+    // Keep track of the ordered feature point feature edges
+    labelListList featurePointFeatureEdges(nFeatPts);
+    forAll(featurePointFeatureEdges, pI)
+    {
+        featurePointFeatureEdges[pI] = pointEdges[featurePoints[pI]];
+    }
+
+    // Mapping between old and new indices, there is entry in the map for each
+    // of surf.localPoints, -1 means that this point hasn't been used (yet),
+    // >= 0 corresponds to the index
+    labelList pointMap(sFeatLocalPts.size(), -1);
+
+    // Mapping between surface edge index and its feature edge index. -1 if it
+    // is not a feature edge
+    labelList edgeMap(sFeatEds.size(), -1);
+
+    // Noting when the normal of a face has been used so not to duplicate
+    labelList faceMap(surf.size(), -1);
+
+    // Collecting the status of edge for subsequent sorting
+    List<edgeStatus> edStatus(nFeatEds, NONE);
+
+    forAll(featurePoints, i)
+    {
+        label sFPI = featurePoints[i];
+
+        tmpPts.append(sFeatLocalPts[sFPI]);
+
+        pointMap[sFPI] = tmpPts.size() - 1;
+    }
+
+    // All feature points have been added
+    nonFeatureStart_ = tmpPts.size();
+
+    PackedBoolList isRegionFeatureEdge(regionFeatureEdges);
+
+    forAll(featureEdges, i)
+    {
+        label sFEI = featureEdges[i];
+
+        edgeMap[sFEI] = i;
+
+        const edge& fE = sFeatEds[sFEI];
+
+        edgeDirections[i] = fE.vec(sFeatLocalPts);
+
+        // Check to see if the points have been already used
+        if (pointMap[fE.start()] == -1)
+        {
+             tmpPts.append(sFeatLocalPts[fE.start()]);
+
+             pointMap[fE.start()] = tmpPts.size() - 1;
+        }
+
+        eds[i].start() = pointMap[fE.start()];
+
+        if (pointMap[fE.end()] == -1)
+        {
+            tmpPts.append(sFeatLocalPts[fE.end()]);
+
+            pointMap[fE.end()] = tmpPts.size() - 1;
+        }
+
+        eds[i].end() = pointMap[fE.end()];
+
+        // Pick up the faces adjacent to the feature edge
+        const labelList& eFaces = edgeFaces[sFEI];
+
+        edgeNormals[i].setSize(eFaces.size());
+        normalDirections[i].setSize(eFaces.size());
+
+        forAll(eFaces, j)
+        {
+            label eFI = eFaces[j];
+
+            // Check to see if the points have been already used
+            if (faceMap[eFI] == -1)
+            {
+                norms.append(faceNormals[eFI]);
+
+                faceMap[eFI] = norms.size() - 1;
+            }
+
+            edgeNormals[i][j] = faceMap[eFI];
+
+            const vector cross = (faceNormals[eFI] ^ edgeDirections[i]);
+            const vector fC0tofE0 =
+                surf[eFI].centre(surf.points())
+              - sFeatLocalPts[fE.start()];
+
+            normalDirections[i][j] =
+                (
+                    (
+                        (cross/(mag(cross) + VSMALL))
+                      & (fC0tofE0/(mag(fC0tofE0)+ VSMALL))
+                    )
+                  > 0.0
+                    ? 1
+                    : -1
+                );
+        }
+
+        vector fC0tofC1(vector::zero);
+
+        if (eFaces.size() == 2)
+        {
+            fC0tofC1 =
+                surf[eFaces[1]].centre(surf.points())
+              - surf[eFaces[0]].centre(surf.points());
+        }
+
+        edStatus[i] = classifyEdge(norms, edgeNormals[i], fC0tofC1);
+
+        if (isRegionFeatureEdge[i])
+        {
+            regionEdges.append(i);
+        }
+    }
+
+    // Populate feature point feature edges
+    DynamicList<label> newFeatureEdges;
+
+    forAll(featurePointFeatureEdges, pI)
+    {
+        const labelList& fpfe = featurePointFeatureEdges[pI];
+
+        newFeatureEdges.setCapacity(fpfe.size());
+
+        forAll(fpfe, eI)
+        {
+            const label oldEdgeIndex = fpfe[eI];
+
+            const label newFeatureEdgeIndex = edgeMap[oldEdgeIndex];
+
+            if (newFeatureEdgeIndex != -1)
+            {
+                newFeatureEdges.append(newFeatureEdgeIndex);
+            }
+        }
+
+        featurePointFeatureEdges[pI].transfer(newFeatureEdges);
+    }
+
+    // Reorder the edges by classification
+    List<DynamicList<label> > allEds(nEdgeTypes);
+
+    DynamicList<label>& externalEds(allEds[0]);
+    DynamicList<label>& internalEds(allEds[1]);
+    DynamicList<label>& flatEds(allEds[2]);
+    DynamicList<label>& openEds(allEds[3]);
+    DynamicList<label>& multipleEds(allEds[4]);
+
+    forAll(eds, i)
+    {
+        edgeStatus eStat = edStatus[i];
+
+        if (eStat == EXTERNAL)
+        {
+            externalEds.append(i);
+        }
+        else if (eStat == INTERNAL)
+        {
+            internalEds.append(i);
+        }
+        else if (eStat == FLAT)
+        {
+            flatEds.append(i);
+        }
+        else if (eStat == OPEN)
+        {
+            openEds.append(i);
+        }
+        else if (eStat == MULTIPLE)
+        {
+            multipleEds.append(i);
+        }
+        else if (eStat == NONE)
+        {
+            FatalErrorIn
+            (
+                ":extendedEdgeMesh::sortPointsAndEdges"
+                "("
+                "    const Patch&,"
+                "    const labelList& featureEdges,"
+                "    const labelList& feaurePoints"
+                ")"
+            )   << nl << "classifyEdge returned NONE on edge "
+                << eds[i]
+                << ". There is a problem with definition of this edge."
+                << nl << abort(FatalError);
+        }
+    }
+
+    internalStart_ = externalEds.size();
+    flatStart_ = internalStart_ + internalEds.size();
+    openStart_ = flatStart_ + flatEds.size();
+    multipleStart_ = openStart_ + openEds.size();
+
+    labelList edMap
+    (
+        ListListOps::combine<labelList>
+        (
+            allEds,
+            accessOp<labelList>()
+        )
+    );
+
+    edMap = invert(edMap.size(), edMap);
+
+    inplaceReorder(edMap, eds);
+    inplaceReorder(edMap, edStatus);
+    inplaceReorder(edMap, edgeDirections);
+    inplaceReorder(edMap, edgeNormals);
+    inplaceReorder(edMap, normalDirections);
+    inplaceRenumber(edMap, regionEdges);
+
+    forAll(featurePointFeatureEdges, pI)
+    {
+        inplaceRenumber(edMap, featurePointFeatureEdges[pI]);
+    }
+
+    pointField pts(tmpPts);
+
+    // Initialise the edgeMesh
+    edgeMesh::operator=(edgeMesh(pts, eds));
+
+    // Initialise sorted edge related data
+    edgeDirections_ = edgeDirections/(mag(edgeDirections) + VSMALL);
+    edgeNormals_ = edgeNormals;
+    normalDirections_ = normalDirections;
+    regionEdges_ = regionEdges;
+
+    // Normals are all now found and indirectly addressed, can also be stored
+    normals_ = vectorField(norms);
+
+
+    // Reorder the feature points by classification
+
+    List<DynamicList<label> > allPts(3);
+
+    DynamicList<label>& convexPts(allPts[0]);
+    DynamicList<label>& concavePts(allPts[1]);
+    DynamicList<label>& mixedPts(allPts[2]);
+
+    for (label i = 0; i < nonFeatureStart_; i++)
+    {
+        pointStatus ptStatus = classifyFeaturePoint(i);
+
+        if (ptStatus == CONVEX)
+        {
+            convexPts.append(i);
+        }
+        else if (ptStatus == CONCAVE)
+        {
+            concavePts.append(i);
+        }
+        else if (ptStatus == MIXED)
+        {
+            mixedPts.append(i);
+        }
+        else if (ptStatus == NONFEATURE)
+        {
+            FatalErrorIn
+            (
+                ":extendedEdgeMesh::sortPointsAndEdges"
+                "("
+                "    const Patch&,"
+                "    const labelList& featureEdges,"
+                "    const labelList& feaurePoints"
+                ")"
+            )   << nl << "classifyFeaturePoint returned NONFEATURE on point at "
+                << points()[i]
+                << ". There is a problem with definition of this feature point."
+                << nl << abort(FatalError);
+        }
+    }
+
+    concaveStart_ = convexPts.size();
+    mixedStart_ = concaveStart_ + concavePts.size();
+
+    labelList ftPtMap
+    (
+        ListListOps::combine<labelList>
+        (
+            allPts,
+            accessOp<labelList>()
+        )
+    );
+
+    ftPtMap = invert(ftPtMap.size(), ftPtMap);
+
+    // Creating the ptMap from the ftPtMap with identity values up to the size
+    // of pts to create an oldToNew map for inplaceReorder
+
+    labelList ptMap(identity(pts.size()));
+
+    forAll(ftPtMap, i)
+    {
+        ptMap[i] = ftPtMap[i];
+    }
+
+    inplaceReorder(ptMap, pts);
+    inplaceReorder(ptMap, featurePointFeatureEdges);
+
+    forAll(eds, i)
+    {
+        inplaceRenumber(ptMap, eds[i]);
+    }
+
+    // Reinitialise the edgeMesh with sorted feature points and
+    // renumbered edges
+    reset(xferMove(pts), xferMove(eds));
+
+    // Generate the featurePointNormals
+
+    labelListList featurePointNormals(nonFeatureStart_);
+
+    for (label i = 0; i < nonFeatureStart_; i++)
+    {
+        DynamicList<label> tmpFtPtNorms;
+
+        const labelList& ptEds = edgeMesh::pointEdges()[i];
+
+        forAll(ptEds, j)
+        {
+            const labelList& ptEdNorms(edgeNormals[ptEds[j]]);
+
+            forAll(ptEdNorms, k)
+            {
+                if (findIndex(tmpFtPtNorms, ptEdNorms[k]) == -1)
+                {
+                    bool addNormal = true;
+
+                    // Check that the normal direction is unique at this feature
+                    forAll(tmpFtPtNorms, q)
+                    {
+                        if
+                        (
+                            (normals_[ptEdNorms[k]] & normals_[tmpFtPtNorms[q]])
+                          > cosNormalAngleTol_
+                        )
+                        {
+                            // Parallel to an existing normal, do not add
+                            addNormal = false;
+
+                            break;
+                        }
+                    }
+
+                    if (addNormal)
+                    {
+                        tmpFtPtNorms.append(ptEdNorms[k]);
+                    }
+                }
+            }
+        }
+
+        featurePointNormals[i] = tmpFtPtNorms;
+    }
+
+    featurePointNormals_ = featurePointNormals;
+    featurePointEdges_ = featurePointFeatureEdges;
+}
+
+
+// ************************************************************************* //
diff --git a/src/edgeMesh/extendedEdgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.C b/src/edgeMesh/extendedEdgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.C
new file mode 100644
index 0000000000000000000000000000000000000000..126b9dcdf8f382d93ee4a142789517fafee72387
--- /dev/null
+++ b/src/edgeMesh/extendedEdgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.C
@@ -0,0 +1,280 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "extendedFeatureEdgeMesh.H"
+#include "Time.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    defineTypeNameAndDebug(extendedFeatureEdgeMesh, 0);
+}
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh(const IOobject& io)
+:
+    regIOobject(io),
+    extendedEdgeMesh()
+{
+    if
+    (
+        io.readOpt() == IOobject::MUST_READ
+     || io.readOpt() == IOobject::MUST_READ_IF_MODIFIED
+     || (io.readOpt() == IOobject::READ_IF_PRESENT && headerOk())
+    )
+    {
+        if (readOpt() == IOobject::MUST_READ_IF_MODIFIED)
+        {
+            WarningIn
+            (
+                "extendedFeatureEdgeMesh::extendedFeatureEdgeMesh"
+                "(const IOobject&)"
+            )   << "Specified IOobject::MUST_READ_IF_MODIFIED but class"
+                << " does not support automatic rereading."
+                << endl;
+        }
+
+        readStream(typeName) >> *this;
+        close();
+
+        {
+            // Calculate edgeDirections
+
+            const edgeList& eds(edges());
+
+            const pointField& pts(points());
+
+            edgeDirections_.setSize(eds.size());
+
+            forAll(eds, eI)
+            {
+                edgeDirections_[eI] = eds[eI].vec(pts);
+            }
+
+            edgeDirections_ /= (mag(edgeDirections_) + SMALL);
+        }
+    }
+
+    if (debug)
+    {
+        Pout<< "extendedFeatureEdgeMesh::extendedFeatureEdgeMesh :"
+            << " constructed from IOobject :"
+            << " points:" << points().size()
+            << " edges:" << edges().size()
+            << endl;
+    }
+}
+
+
+Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh
+(
+    const IOobject& io,
+    const extendedEdgeMesh& em
+)
+:
+    regIOobject(io),
+    extendedEdgeMesh(em)
+{}
+
+
+Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh
+(
+    const surfaceFeatures& sFeat,
+    const objectRegistry& obr,
+    const fileName& sFeatFileName,
+    const boolList& surfBaffleRegions
+)
+:
+    regIOobject
+    (
+        IOobject
+        (
+            sFeatFileName,
+            obr.time().constant(),
+            "extendedFeatureEdgeMesh",
+            obr,
+            IOobject::NO_READ,
+            IOobject::NO_WRITE
+        )
+    ),
+    extendedEdgeMesh(sFeat, surfBaffleRegions)
+{}
+
+
+Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh
+(
+    const IOobject& io,
+    const PrimitivePatch<face, List, pointField, point>& surf,
+    const labelList& featureEdges,
+    const labelList& regionFeatureEdges,
+    const labelList& featurePoints
+)
+:
+    regIOobject(io),
+    extendedEdgeMesh(surf, featureEdges, regionFeatureEdges, featurePoints)
+{}
+
+
+Foam::extendedFeatureEdgeMesh::extendedFeatureEdgeMesh
+(
+    const IOobject& io,
+    const pointField& pts,
+    const edgeList& eds,
+    label concaveStart,
+    label mixedStart,
+    label nonFeatureStart,
+    label internalStart,
+    label flatStart,
+    label openStart,
+    label multipleStart,
+    const vectorField& normals,
+    const List<sideVolumeType>& normalVolumeTypes,
+    const vectorField& edgeDirections,
+    const labelListList& normalDirections,
+    const labelListList& edgeNormals,
+    const labelListList& featurePointNormals,
+    const labelListList& featurePointEdges,
+    const labelList& regionEdges
+)
+:
+    regIOobject(io),
+    extendedEdgeMesh
+    (
+        pts,
+        eds,
+        concaveStart,
+        mixedStart,
+        nonFeatureStart,
+        internalStart,
+        flatStart,
+        openStart,
+        multipleStart,
+        normals,
+        normalVolumeTypes,
+        edgeDirections,
+        normalDirections,
+        edgeNormals,
+        featurePointNormals,
+        featurePointEdges,
+        regionEdges
+    )
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+Foam::extendedFeatureEdgeMesh::~extendedFeatureEdgeMesh()
+{}
+
+
+// * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * * //
+
+
+// * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
+
+bool Foam::extendedFeatureEdgeMesh::readData(Istream& is)
+{
+    is >> *this;
+    return !is.bad();
+}
+
+
+bool Foam::extendedFeatureEdgeMesh::writeData(Ostream& os) const
+{
+    os << *this;
+
+    return os.good();
+}
+
+
+
+//bool Foam::extendedFeatureEdgeMesh::writeData(Ostream& os) const
+//{
+//    os  << "// points" << nl
+//        << points() << nl
+//        << "// edges" << nl
+//        << edges() << nl
+//        << "// concaveStart mixedStart nonFeatureStart" << nl
+//        << concaveStart_ << token::SPACE
+//        << mixedStart_ << token::SPACE
+//        << nonFeatureStart_ << nl
+//        << "// internalStart flatStart openStart multipleStart" << nl
+//        << internalStart_ << token::SPACE
+//        << flatStart_ << token::SPACE
+//        << openStart_ << token::SPACE
+//        << multipleStart_ << nl
+//        << "// normals" << nl
+//        << normals_ << nl
+//        << "// normal volume types" << nl
+//        << normalVolumeTypes_ << nl
+//        << "// normalDirections" << nl
+//        << normalDirections_ << nl
+//        << "// edgeNormals" << nl
+//        << edgeNormals_ << nl
+//        << "// featurePointNormals" << nl
+//        << featurePointNormals_ << nl
+//        << "// featurePointEdges" << nl
+//        << featurePointEdges_ << nl
+//        << "// regionEdges" << nl
+//        << regionEdges_
+//        << endl;
+//
+//    return os.good();
+//}
+
+//
+//Foam::Istream& Foam::operator>>
+//(
+//    Istream& is,
+//    Foam::extendedFeatureEdgeMesh::sideVolumeType& vt
+//)
+//{
+//    label type;
+//    is  >> type;
+//
+//    vt = static_cast<Foam::extendedFeatureEdgeMesh::sideVolumeType>(type);
+//
+//    // Check state of Istream
+//    is.check("operator>>(Istream&, sideVolumeType&)");
+//
+//    return is;
+//}
+//
+//
+//Foam::Ostream& Foam::operator<<
+//(
+//    Ostream& os,
+//    const Foam::extendedFeatureEdgeMesh::sideVolumeType& vt
+//)
+//{
+//    os  << static_cast<label>(vt);
+//
+//    return os;
+//}
+//
+
+// ************************************************************************* //
diff --git a/src/edgeMesh/extendedEdgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.H b/src/edgeMesh/extendedEdgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.H
new file mode 100644
index 0000000000000000000000000000000000000000..3026f15b4e1fc770bacb886f35272d59fbe1725e
--- /dev/null
+++ b/src/edgeMesh/extendedEdgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMesh.H
@@ -0,0 +1,149 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::extendedFeatureEdgeMesh
+
+Description
+
+    extendedEdgeMesh + IO.
+
+SourceFiles
+    extendedFeatureEdgeMesh.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef extendedFeatureEdgeMesh_H
+#define extendedFeatureEdgeMesh_H
+
+#include "extendedEdgeMesh.H"
+#include "regIOobject.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+class objectRegistry;
+
+/*---------------------------------------------------------------------------*\
+                       Class extendedFeatureEdgeMesh Declaration
+\*---------------------------------------------------------------------------*/
+
+class extendedFeatureEdgeMesh
+:
+    public regIOobject,
+    public extendedEdgeMesh
+{
+
+public:
+
+    //- Runtime type information
+    TypeName("extendedFeatureEdgeMesh");
+
+
+    // Constructors
+
+        //- Construct (read) given an IOobject
+        extendedFeatureEdgeMesh(const IOobject&);
+
+        //- Construct as copy
+        extendedFeatureEdgeMesh
+        (
+            const IOobject&,
+            const extendedEdgeMesh&
+        );
+
+        //- Construct given a surface with selected edges,point
+        //  (surfaceFeatures), an objectRegistry and a
+        //  fileName to write to.
+        //  Extracts, classifies and reorders the data from surfaceFeatures.
+        extendedFeatureEdgeMesh
+        (
+            const surfaceFeatures& sFeat,
+            const objectRegistry& obr,
+            const fileName& sFeatFileName,
+            const boolList& surfBaffleRegions
+        );
+
+        //- Construct from PrimitivePatch
+        extendedFeatureEdgeMesh
+        (
+            const IOobject&,
+            const PrimitivePatch<face, List, pointField, point>& surf,
+            const labelList& featureEdges,
+            const labelList& regionFeatureEdges,
+            const labelList& featurePoints
+        );
+
+        //- Construct from all components
+        extendedFeatureEdgeMesh
+        (
+            const IOobject& io,
+            const pointField& pts,
+            const edgeList& eds,
+            label concaveStart,
+            label mixedStart,
+            label nonFeatureStart,
+            label internalStart,
+            label flatStart,
+            label openStart,
+            label multipleStart,
+            const vectorField& normals,
+            const List<sideVolumeType>& normalVolumeTypes,
+            const vectorField& edgeDirections,
+            const labelListList& normalDirections,
+            const labelListList& edgeNormals,
+            const labelListList& featurePointNormals,
+            const labelListList& featurePointEdges,
+            const labelList& regionEdges
+        );
+
+
+    //- Destructor
+    virtual ~extendedFeatureEdgeMesh();
+
+
+    // IO
+
+        //- Give precedence to the regIOobject write
+        using regIOobject::write;
+
+        //- ReadData function required for regIOobject read operation
+        virtual bool readData(Istream&);
+
+        //- WriteData function required for regIOobject write operation
+        virtual bool writeData(Ostream&) const;
+
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/edgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshI.H b/src/edgeMesh/extendedEdgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshI.H
similarity index 100%
rename from src/edgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshI.H
rename to src/edgeMesh/extendedEdgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshI.H
diff --git a/src/edgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshTemplates.C b/src/edgeMesh/extendedEdgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshTemplates.C
similarity index 100%
rename from src/edgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshTemplates.C
rename to src/edgeMesh/extendedEdgeMesh/extendedFeatureEdgeMesh/extendedFeatureEdgeMeshTemplates.C
diff --git a/src/finiteVolume/Make/files b/src/finiteVolume/Make/files
index 0bcfcf48a575f19a1d2aa01748f8e5ba00385db1..d7ea0f00996f6b171414068c5ff2c8463bbe7dd3 100644
--- a/src/finiteVolume/Make/files
+++ b/src/finiteVolume/Make/files
@@ -251,6 +251,8 @@ surfaceInterpolation = interpolation/surfaceInterpolation
 $(surfaceInterpolation)/surfaceInterpolation/surfaceInterpolation.C
 $(surfaceInterpolation)/surfaceInterpolationScheme/surfaceInterpolationSchemes.C
 
+$(surfaceInterpolation)/blendedSchemeBase/blendedSchemeBaseName.C
+
 schemes = $(surfaceInterpolation)/schemes
 $(schemes)/linear/linear.C
 $(schemes)/pointLinear/pointLinear.C
diff --git a/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/flowRateInletVelocityFvPatchVectorField.C b/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/flowRateInletVelocityFvPatchVectorField.C
index c59d8d89ee43617be7a238f83b7a176e39cba1a8..e05c34aa208c3e90f42a13a70961851554010c46 100644
--- a/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/flowRateInletVelocityFvPatchVectorField.C
+++ b/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/flowRateInletVelocityFvPatchVectorField.C
@@ -199,10 +199,7 @@ void Foam::flowRateInletVelocityFvPatchVectorField::updateCoeffs()
     else
     {
         // mass flow-rate
-        if
-        (
-            patch().boundaryMesh().mesh().foundObject<volScalarField>(rhoName_)
-        )
+        if (db().foundObject<volScalarField>(rhoName_))
         {
             const fvPatchField<scalar>& rhop =
                 patch().lookupPatchField<volScalarField, scalar>(rhoName_);
diff --git a/src/finiteVolume/finiteVolume/convectionSchemes/gaussConvectionScheme/gaussConvectionScheme.C b/src/finiteVolume/finiteVolume/convectionSchemes/gaussConvectionScheme/gaussConvectionScheme.C
index c814f220601e2618adc0cc1976e8bed0e15e6529..1c68b9cf12eb497f20b35a12bd84e913a6838f5d 100644
--- a/src/finiteVolume/finiteVolume/convectionSchemes/gaussConvectionScheme/gaussConvectionScheme.C
+++ b/src/finiteVolume/finiteVolume/convectionSchemes/gaussConvectionScheme/gaussConvectionScheme.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-2013 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -39,6 +39,14 @@ namespace fv
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
+template<class Type>
+const surfaceInterpolationScheme<Type>&
+gaussConvectionScheme<Type>::interpScheme() const
+{
+    return tinterpScheme_();
+}
+
+
 template<class Type>
 tmp<GeometricField<Type, fvsPatchField, surfaceMesh> >
 gaussConvectionScheme<Type>::interpolate
diff --git a/src/finiteVolume/finiteVolume/convectionSchemes/gaussConvectionScheme/gaussConvectionScheme.H b/src/finiteVolume/finiteVolume/convectionSchemes/gaussConvectionScheme/gaussConvectionScheme.H
index 61d6c22d37aadd055fa8546a2ddbab561760b6ad..a3ce0d1ec0d02ac8e23db84cd220c707023ae09d 100644
--- a/src/finiteVolume/finiteVolume/convectionSchemes/gaussConvectionScheme/gaussConvectionScheme.H
+++ b/src/finiteVolume/finiteVolume/convectionSchemes/gaussConvectionScheme/gaussConvectionScheme.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -134,6 +134,8 @@ public:
 
     // Member Functions
 
+        const surfaceInterpolationScheme<Type>& interpScheme() const;
+
         tmp<GeometricField<Type, fvsPatchField, surfaceMesh> > interpolate
         (
             const surfaceScalarField&,
diff --git a/src/finiteVolume/finiteVolume/fvc/fvcCellReduce.C b/src/finiteVolume/finiteVolume/fvc/fvcCellReduce.C
new file mode 100644
index 0000000000000000000000000000000000000000..63c718375bf950119b8592ddd0966eb3cc796d64
--- /dev/null
+++ b/src/finiteVolume/finiteVolume/fvc/fvcCellReduce.C
@@ -0,0 +1,118 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "fvcCellReduce.H"
+#include "fvMesh.H"
+#include "volFields.H"
+#include "surfaceFields.H"
+#include "zeroGradientFvPatchFields.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace fvc
+{
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+template<class Type, class CombineOp>
+tmp<GeometricField<Type, fvPatchField, volMesh> > cellReduce
+(
+    const GeometricField<Type, fvsPatchField, surfaceMesh>& ssf,
+    const CombineOp& cop
+)
+{
+    typedef GeometricField<Type, fvPatchField, volMesh> volFieldType;
+
+    const fvMesh& mesh = ssf.mesh();
+
+    tmp<volFieldType> tresult
+    (
+        new volFieldType
+        (
+            IOobject
+            (
+                "cellReduce(" + ssf.name() + ')',
+                ssf.instance(),
+                mesh,
+                IOobject::NO_READ,
+                IOobject::NO_WRITE
+            ),
+            mesh,
+            dimensioned<Type>("0", ssf.dimensions(), pTraits<Type>::zero),
+            zeroGradientFvPatchField<Type>::typeName
+        )
+    );
+
+    volFieldType& result = tresult();
+
+    const labelUList& own = mesh.owner();
+    const labelUList& nbr = mesh.neighbour();
+
+    forAll(own, i)
+    {
+        label cellI = own[i];
+        cop(result[cellI], ssf[i]);
+    }
+    forAll(nbr, i)
+    {
+        label cellI = nbr[i];
+        cop(result[cellI], ssf[i]);
+    }
+
+    result.correctBoundaryConditions();
+
+    return tresult;
+}
+
+
+template<class Type, class CombineOp>
+tmp<GeometricField<Type, fvPatchField, volMesh> > cellReduce
+(
+    const tmp<GeometricField<Type, fvsPatchField, surfaceMesh>&> tssf,
+    const CombineOp& cop
+)
+{
+    tmp<GeometricField<Type, fvPatchField, volMesh> >
+        tvf(cellReduce(cop, tssf));
+
+   tssf.clear();
+    return tvf;
+}
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace fvc
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// ************************************************************************* //
diff --git a/src/finiteVolume/finiteVolume/fvc/fvcCellReduce.H b/src/finiteVolume/finiteVolume/fvc/fvcCellReduce.H
new file mode 100644
index 0000000000000000000000000000000000000000..19bd24135af0a4dd75a11ca446192301e0e6443a
--- /dev/null
+++ b/src/finiteVolume/finiteVolume/fvc/fvcCellReduce.H
@@ -0,0 +1,82 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+InNamespace
+    Foam::fvc
+
+Description
+    Construct a volume field from a surface field using a combine operator.
+
+SourceFiles
+    fvcCellReduce.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef fvcCellReduce_H
+#define fvcCellReduce_H
+
+#include "volFieldsFwd.H"
+#include "surfaceFieldsFwd.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+/*---------------------------------------------------------------------------*\
+                      Namespace fvc functions Declaration
+\*---------------------------------------------------------------------------*/
+
+namespace fvc
+{
+    template<class Type, class CombineOp>
+    tmp<GeometricField<Type, fvPatchField, volMesh> > cellReduce
+    (
+        const GeometricField<Type, fvsPatchField, surfaceMesh>&,
+        const CombineOp& cop
+    );
+
+    template<class Type, class CombineOp>
+    tmp<GeometricField<Type, fvPatchField, volMesh> > cellReduce
+    (
+        const tmp<GeometricField<Type, fvsPatchField, surfaceMesh> >&,
+        const CombineOp& cop
+    );
+}
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "fvcCellReduce.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/finiteVolume/fvMesh/fvMesh.C b/src/finiteVolume/fvMesh/fvMesh.C
index 26c3b3342381c39d8427508fcafe163becc0116a..8f99d1f61782495b830bfb8bd3f98ce0a0041f4e 100644
--- a/src/finiteVolume/fvMesh/fvMesh.C
+++ b/src/finiteVolume/fvMesh/fvMesh.C
@@ -110,10 +110,42 @@ void Foam::fvMesh::clearGeom()
 }
 
 
-void Foam::fvMesh::clearAddressing()
+void Foam::fvMesh::clearAddressing(const bool isMeshUpdate)
 {
-    meshObject::clear<fvMesh, TopologicalMeshObject>(*this);
-    meshObject::clear<lduMesh, TopologicalMeshObject>(*this);
+    if (debug)
+    {
+        Info<< "fvMesh::clearAddressing(const bool) :"
+            << " isMeshUpdate:" << isMeshUpdate << endl;
+    }
+
+    if (isMeshUpdate)
+    {
+        // Part of a mesh update. Keep meshObjects that have an updateMesh
+        // callback
+        meshObject::clearUpto
+        <
+            fvMesh,
+            TopologicalMeshObject,
+            UpdateableMeshObject
+        >
+        (
+            *this
+        );
+        meshObject::clearUpto
+        <
+            lduMesh,
+            TopologicalMeshObject,
+            UpdateableMeshObject
+        >
+        (
+            *this
+        );
+    }
+    else
+    {
+        meshObject::clear<fvMesh, TopologicalMeshObject>(*this);
+        meshObject::clear<lduMesh, TopologicalMeshObject>(*this);
+    }
     deleteDemandDrivenData(lduPtr_);
 }
 
@@ -806,7 +838,8 @@ void Foam::fvMesh::updateMesh(const mapPolyMesh& mpm)
     // Clear the current volume and other geometry factors
     surfaceInterpolation::clearOut();
 
-    clearAddressing();
+    // Clear any non-updateable addressing
+    clearAddressing(true);
 
     meshObject::updateMesh<fvMesh>(*this, mpm);
     meshObject::updateMesh<lduMesh>(*this, mpm);
diff --git a/src/finiteVolume/fvMesh/fvMesh.H b/src/finiteVolume/fvMesh/fvMesh.H
index c6c234c495811327949535fa8907e67647e668a5..47c03db1156ce2a84e7546484850c142cd0cef17 100644
--- a/src/finiteVolume/fvMesh/fvMesh.H
+++ b/src/finiteVolume/fvMesh/fvMesh.H
@@ -141,7 +141,7 @@ class fvMesh
             void clearGeom();
 
             //- Clear addressing
-            void clearAddressing();
+            void clearAddressing(const bool isMeshUpdate = false);
 
             //- Preserve old volume(s)
             void storeOldVol(const scalarField&);
diff --git a/src/finiteVolume/interpolation/surfaceInterpolation/blendedSchemeBase/blendedSchemeBase.H b/src/finiteVolume/interpolation/surfaceInterpolation/blendedSchemeBase/blendedSchemeBase.H
new file mode 100644
index 0000000000000000000000000000000000000000..2c485e01477edcf0740317437b98d62d0fc4d75f
--- /dev/null
+++ b/src/finiteVolume/interpolation/surfaceInterpolation/blendedSchemeBase/blendedSchemeBase.H
@@ -0,0 +1,87 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::blendedSchemeBase
+
+Description
+    Base class for blended schemes to provide access to the blending factor
+    surface field
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef blendedSchemeBase_H
+#define blendedSchemeBase_H
+
+#include "className.H"
+#include "tmp.H"
+#include "surfaceFieldsFwd.H"
+#include "volFieldsFwd.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+TemplateName(blendedSchemeBase);
+
+/*---------------------------------------------------------------------------*\
+                      Class blendedSchemeBase Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class Type>
+class blendedSchemeBase
+:
+    public blendedSchemeBaseName
+{
+
+public:
+
+    //- Constructor
+    blendedSchemeBase()
+    {}
+
+    //- Destructor
+    virtual ~blendedSchemeBase()
+    {}
+
+
+    // Memeber Functions
+
+        //- Return the face-based blending factor
+        virtual tmp<surfaceScalarField> blendingFactor
+        (
+             const GeometricField<Type, fvPatchField, volMesh>& vf
+        ) const = 0;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/finiteVolume/interpolation/surfaceInterpolation/blendedSchemeBase/blendedSchemeBaseName.C b/src/finiteVolume/interpolation/surfaceInterpolation/blendedSchemeBase/blendedSchemeBaseName.C
new file mode 100644
index 0000000000000000000000000000000000000000..0a97d7f617b49805ea7502176dc0acca2295be4c
--- /dev/null
+++ b/src/finiteVolume/interpolation/surfaceInterpolation/blendedSchemeBase/blendedSchemeBaseName.C
@@ -0,0 +1,36 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "blendedSchemeBase.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    defineTypeNameAndDebug(blendedSchemeBaseName, 0);
+}
+
+
+// ************************************************************************* //
diff --git a/src/finiteVolume/interpolation/surfaceInterpolation/limitedSchemes/blended/blended.H b/src/finiteVolume/interpolation/surfaceInterpolation/limitedSchemes/blended/blended.H
index 6d207fcdcde08bfedfa59287d128464109a5b2b0..f58b8c2393b4119a847702eb342d28e72e537b57 100644
--- a/src/finiteVolume/interpolation/surfaceInterpolation/limitedSchemes/blended/blended.H
+++ b/src/finiteVolume/interpolation/surfaceInterpolation/limitedSchemes/blended/blended.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-2013 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -36,6 +36,7 @@ SourceFiles
 #define blended_H
 
 #include "limitedSurfaceInterpolationScheme.H"
+#include "blendedSchemeBase.H"
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
@@ -49,7 +50,8 @@ namespace Foam
 template<class Type>
 class blended
 :
-    public limitedSurfaceInterpolationScheme<Type>
+    public limitedSurfaceInterpolationScheme<Type>,
+    public blendedSchemeBase<Type>
 {
     // Private data
 
@@ -111,8 +113,40 @@ public:
         {}
 
 
+    //- Destructor
+    virtual ~blended()
+    {}
+
+
     // Member Functions
 
+        //- Return the face-based blending factor
+        virtual tmp<surfaceScalarField> blendingFactor
+        (
+             const GeometricField<Type, fvPatchField, volMesh>& vf
+        ) const
+        {
+            return tmp<surfaceScalarField>
+            (
+                new surfaceScalarField
+                (
+                    IOobject
+                    (
+                        vf.name() + "BlendingFactor",
+                        this->mesh().time().timeName(),
+                        this->mesh()
+                    ),
+                    this->mesh(),
+                    dimensionedScalar
+                    (
+                        "blendingFactor",
+                        dimless,
+                        blendingFactor_
+                    )
+                )
+            );
+        }
+
         //- Return the interpolation limiter
         virtual tmp<surfaceScalarField> limiter
         (
diff --git a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/CoBlended/CoBlended.H b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/CoBlended/CoBlended.H
index e8ed67a9d836ebc1f7e01ed3f8de9e8608b2947b..3f15520061c879c341d7093a997462daa162c12a 100644
--- a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/CoBlended/CoBlended.H
+++ b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/CoBlended/CoBlended.H
@@ -63,6 +63,7 @@ SourceFiles
 #define CoBlended_H
 
 #include "surfaceInterpolationScheme.H"
+#include "blendedSchemeBase.H"
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
@@ -76,7 +77,8 @@ namespace Foam
 template<class Type>
 class CoBlended
 :
-    public surfaceInterpolationScheme<Type>
+    public surfaceInterpolationScheme<Type>,
+    public blendedSchemeBase<Type>
 {
     // Private data
 
@@ -135,10 +137,7 @@ public:
             ),
             faceFlux_
             (
-                mesh.lookupObject<surfaceScalarField>
-                (
-                    word(is)
-                )
+                mesh.lookupObject<surfaceScalarField>(word(is))
             )
         {
             if (Co1_ < 0 || Co2_ < 0 || Co1_ >= Co2_)
@@ -170,7 +169,7 @@ public:
             (
                 surfaceInterpolationScheme<Type>::New(mesh, faceFlux, is)
             ),
-             faceFlux_(faceFlux)
+            faceFlux_(faceFlux)
         {
             if (Co1_ < 0 || Co2_ < 0 || Co1_ >= Co2_)
             {
@@ -182,17 +181,39 @@ public:
         }
 
 
+    //- Destructor
+    virtual ~CoBlended()
+    {}
+
+
     // Member Functions
 
-        //- Return the face-based Courant number blending factor
-        tmp<surfaceScalarField> blendingFactor() const
+        //- Return the face-based blending factor
+        virtual tmp<surfaceScalarField> blendingFactor
+        (
+             const GeometricField<Type, fvPatchField, volMesh>& vf
+        ) const
         {
-            const fvMesh& mesh = faceFlux_.mesh();
+            const fvMesh& mesh = this->mesh();
 
-            return
+            tmp<surfaceScalarField> tbf
             (
-                scalar(1) -
-                max
+                new surfaceScalarField
+                (
+                    IOobject
+                    (
+                        vf.name() + "BlendingFactor",
+                        mesh.time().timeName(),
+                        mesh
+                    ),
+                    mesh,
+                    dimensionedScalar("blendingFactor", dimless, 0.0)
+                )
+            );
+
+            tbf() =
+                scalar(1)
+              - max
                 (
                     min
                     (
@@ -204,8 +225,9 @@ public:
                         scalar(1)
                     ),
                     scalar(0)
-                )
-            );
+                );
+
+            return tbf;
         }
 
 
@@ -216,9 +238,10 @@ public:
             const GeometricField<Type, fvPatchField, volMesh>& vf
         ) const
         {
-            surfaceScalarField bf(blendingFactor());
+            surfaceScalarField bf(blendingFactor(vf));
 
-            Info<< "weights " << max(bf) << " " << min(bf) << endl;
+            Info<< "weights " << max(bf).value() << " " << min(bf).value()
+                << endl;
 
             return
                 bf*tScheme1_().weights(vf)
@@ -234,7 +257,7 @@ public:
             const GeometricField<Type, fvPatchField, volMesh>& vf
         ) const
         {
-            surfaceScalarField bf(blendingFactor());
+            surfaceScalarField bf(blendingFactor(vf));
 
             return
                 bf*tScheme1_().interpolate(vf)
@@ -257,7 +280,7 @@ public:
             const GeometricField<Type, fvPatchField, volMesh>& vf
         ) const
         {
-            surfaceScalarField bf(blendingFactor());
+            surfaceScalarField bf(blendingFactor(vf));
 
             if (tScheme1_().corrected())
             {
diff --git a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/localBlended/localBlended.H b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/localBlended/localBlended.H
index 5f49be98fd2348f75b2586ccf225c602fdaa13b3..0e85f0ea7620ff97734e3ec8012a91e420194664 100644
--- a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/localBlended/localBlended.H
+++ b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/localBlended/localBlended.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-2013 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -36,6 +36,7 @@ SourceFiles
 #define localBlended_H
 
 #include "surfaceInterpolationScheme.H"
+#include "blendedSchemeBase.H"
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
@@ -49,7 +50,8 @@ namespace Foam
 template<class Type>
 class localBlended
 :
-    public surfaceInterpolationScheme<Type>
+    public surfaceInterpolationScheme<Type>,
+    public blendedSchemeBase<Type>
 {
     // Private Member Functions
 
@@ -115,8 +117,27 @@ public:
         {}
 
 
+    //- Destructor
+    virtual ~localBlended()
+    {}
+
+
     // Member Functions
 
+        //- Return the face-based blending factor
+        virtual tmp<surfaceScalarField> blendingFactor
+        (
+             const GeometricField<Type, fvPatchField, volMesh>& vf
+        ) const
+        {
+            return
+                this->mesh().objectRegistry::template
+                    lookupObject<const surfaceScalarField>
+                    (
+                        word(vf.name() + "BlendingFactor")
+                    );
+        }
+
         //- Return the interpolation weighting factors
         tmp<surfaceScalarField> weights
         (
@@ -125,10 +146,10 @@ public:
         {
             const surfaceScalarField& blendingFactor =
                 this->mesh().objectRegistry::template
-                lookupObject<const surfaceScalarField>
-                (
-                    word(vf.name() + "BlendingFactor")
-                );
+                    lookupObject<const surfaceScalarField>
+                    (
+                        word(vf.name() + "BlendingFactor")
+                    );
 
             return
                 blendingFactor*tScheme1_().weights(vf)
diff --git a/src/finiteVolume/interpolation/volPointInterpolation/pointConstraints.C b/src/finiteVolume/interpolation/volPointInterpolation/pointConstraints.C
index 5bc4d56e9414f88583067db33246031a7a68d57a..4993bae684d5ea474236daaa4e6359a9ba5bb774 100644
--- a/src/finiteVolume/interpolation/volPointInterpolation/pointConstraints.C
+++ b/src/finiteVolume/interpolation/volPointInterpolation/pointConstraints.C
@@ -51,11 +51,11 @@ void pointConstraints::makePatchPatchAddressing()
             << endl;
     }
 
-    //const polyMesh& mesh = mesh();
-    const pointMesh& pMesh = pointMesh::New(mesh());
+    const pointMesh& pMesh = mesh();
+    const polyMesh& mesh = pMesh();
 
     const pointBoundaryMesh& pbm = pMesh.boundary();
-    const polyBoundaryMesh& bm = mesh().boundaryMesh();
+    const polyBoundaryMesh& bm = mesh.boundaryMesh();
 
 
     // first count the total number of patch-patch points
@@ -146,7 +146,7 @@ void pointConstraints::makePatchPatchAddressing()
     // ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
 
     {
-        const globalMeshData& gd = mesh().globalData();
+        const globalMeshData& gd = mesh.globalData();
         const labelListList& globalPointSlaves = gd.globalPointSlaves();
         const mapDistribute& globalPointSlavesMap = gd.globalPointSlavesMap();
         const Map<label>& cpPointMap = gd.coupledPatch().meshPointMap();
@@ -226,7 +226,7 @@ void pointConstraints::makePatchPatchAddressing()
                 {
                     //Pout<< "on meshpoint:" << meshPointI
                     //    << " coupled:" << coupledPointI
-                    //    << " at:" << mesh().points()[meshPointI]
+                    //    << " at:" << mesh.points()[meshPointI]
                     //    << " have new constraint:"
                     //    << constraints[coupledPointI]
                     //    << endl;
@@ -244,7 +244,7 @@ void pointConstraints::makePatchPatchAddressing()
                 {
                     //Pout<< "on meshpoint:" << meshPointI
                     //    << " coupled:" << coupledPointI
-                    //    << " at:" << mesh().points()[meshPointI]
+                    //    << " at:" << mesh.points()[meshPointI]
                     //    << " have possibly extended constraint:"
                     //    << constraints[coupledPointI]
                     //    << endl;
@@ -323,10 +323,9 @@ void pointConstraints::makePatchPatchAddressing()
 
 // * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * * //
 
-//pointConstraints::pointConstraints(const pointMesh& pm)
-pointConstraints::pointConstraints(const polyMesh& pm)
+pointConstraints::pointConstraints(const pointMesh& pm)
 :
-    MeshObject<polyMesh, Foam::UpdateableMeshObject, pointConstraints>(pm)
+    MeshObject<pointMesh, Foam::UpdateableMeshObject, pointConstraints>(pm)
 {
     makePatchPatchAddressing();
 }
@@ -381,9 +380,9 @@ void pointConstraints::constrainDisplacement
 
     // Apply any 2D motion constraints (or should they go before
     // corner constraints?)
-    twoDPointCorrector::New(mesh()).correctDisplacement
+    twoDPointCorrector::New(mesh()()).correctDisplacement
     (
-        mesh().points(),
+        mesh()().points(),
         pf.internalField()
     );
 
diff --git a/src/finiteVolume/interpolation/volPointInterpolation/pointConstraints.H b/src/finiteVolume/interpolation/volPointInterpolation/pointConstraints.H
index b5256155ee7cdb60e497a5d8b8bc9cc680430c06..06515ba003b58673103035ccacd551457003c452 100644
--- a/src/finiteVolume/interpolation/volPointInterpolation/pointConstraints.H
+++ b/src/finiteVolume/interpolation/volPointInterpolation/pointConstraints.H
@@ -34,11 +34,6 @@ Description
           coupled to points which are not on any constraint patch and we
           don't want to get inconsistency between the two points.
 
-    Note: is currently MeshObject on polyMesh but should really be on
-          pointMesh. The problem is that pointMesh::updateMesh never
-          gets called (since currently polyMesh gets reset and destroys
-          pointMesh)
-
 SourceFiles
     pointConstraints.C
     pointConstraintsTemplates.C
@@ -67,8 +62,7 @@ class polyMesh;
 
 class pointConstraints
 :
-//See above:public MeshObject<pointMesh, UpdateableMeshObject, pointConstraints>
-    public MeshObject<polyMesh, UpdateableMeshObject, pointConstraints>
+    public MeshObject<pointMesh, UpdateableMeshObject, pointConstraints>
 {
     // Private data
 
@@ -103,8 +97,7 @@ public:
     // Constructors
 
         //- Constructor from pointMesh.
-        //explicit pointConstraints(const pointMesh&);
-        explicit pointConstraints(const polyMesh&);
+        explicit pointConstraints(const pointMesh&);
 
 
     //- Destructor
diff --git a/src/finiteVolume/interpolation/volPointInterpolation/pointConstraintsTemplates.C b/src/finiteVolume/interpolation/volPointInterpolation/pointConstraintsTemplates.C
index c30ee47c2a0374e792340498c11e758811d2a93d..724d827e7ffec97fab2bed41bd132bd374a398f4 100644
--- a/src/finiteVolume/interpolation/volPointInterpolation/pointConstraintsTemplates.C
+++ b/src/finiteVolume/interpolation/volPointInterpolation/pointConstraintsTemplates.C
@@ -139,12 +139,7 @@ void pointConstraints::constrain
     pf.correctBoundaryConditions();
 
     // Sync any dangling points
-    syncUntransformedData
-    (
-        pf.mesh()(),
-        pf.internalField(),
-        maxMagSqrEqOp<Type>()
-    );
+    syncUntransformedData(mesh()(), pf.internalField(), maxMagSqrEqOp<Type>());
 
     // Apply multiple constraints on edge/corner points
     constrainCorners(pf);
diff --git a/src/finiteVolume/interpolation/volPointInterpolation/volPointInterpolate.C b/src/finiteVolume/interpolation/volPointInterpolation/volPointInterpolate.C
index 16b3abed4edc9bc2d5507f57983061f1fd553739..2c9bf7d5e4b1d601cce470a11069aa6026a382de 100644
--- a/src/finiteVolume/interpolation/volPointInterpolation/volPointInterpolate.C
+++ b/src/finiteVolume/interpolation/volPointInterpolation/volPointInterpolate.C
@@ -271,7 +271,7 @@ void volPointInterpolation::interpolateBoundaryField
     interpolateBoundaryField(vf, pf);
 
     // Apply constraints
-    const pointConstraints& pcs = pointConstraints::New(vf.mesh());
+    const pointConstraints& pcs = pointConstraints::New(pf.mesh());
 
     pcs.constrain(pf, overrideFixedValue);
 }
diff --git a/src/finiteVolume/interpolation/volPointInterpolation/volPointInterpolation.C b/src/finiteVolume/interpolation/volPointInterpolation/volPointInterpolation.C
index 53e1e4c448488ff3ede623e8ae15f409741adf09..7a307d31ae697aa52b00b76d949ddf59c72cacc0 100644
--- a/src/finiteVolume/interpolation/volPointInterpolation/volPointInterpolation.C
+++ b/src/finiteVolume/interpolation/volPointInterpolation/volPointInterpolation.C
@@ -390,7 +390,7 @@ void volPointInterpolation::interpolateDisplacement
     interpolateBoundaryField(vf, pf);
 
     // Apply displacement constraints
-    const pointConstraints& pcs = pointConstraints::New(vf.mesh());
+    const pointConstraints& pcs = pointConstraints::New(pf.mesh());
 
     pcs.constrainDisplacement(pf, false);
 }
diff --git a/src/fvOptions/fvOptions/fvIOoptionList.C b/src/fvOptions/fvOptions/fvIOoptionList.C
index 287e4171be455dd9856a37eeaf0530260324ffe4..0a7ab4e6fc9f50b891253d378699cbc804b0101b 100644
--- a/src/fvOptions/fvOptions/fvIOoptionList.C
+++ b/src/fvOptions/fvOptions/fvIOoptionList.C
@@ -45,7 +45,7 @@ Foam::IOobject Foam::fv::IOoptionList::createIOobject
 
     if (io.headerOk())
     {
-        Info<< "Creating fintite volume options from " << io.name() << nl
+        Info<< "Creating finite volume options from " << io.name() << nl
             << endl;
 
         io.readOpt() = IOobject::MUST_READ_IF_MODIFIED;
diff --git a/src/fvOptions/sources/derived/MRFSource/MRFSource.C b/src/fvOptions/sources/derived/MRFSource/MRFSource.C
index d9b4a2a9b94b35b2437384a300d0e6466c084c0d..5dc8ba9fbe63663b62581259fe94085ce83fdc34 100644
--- a/src/fvOptions/sources/derived/MRFSource/MRFSource.C
+++ b/src/fvOptions/sources/derived/MRFSource/MRFSource.C
@@ -52,7 +52,7 @@ void Foam::fv::MRFSource::initialise()
     if (selectionMode_ != smCellZone)
     {
         FatalErrorIn("void Foam::MRFSource::initialise()")
-            << "The porosity region must be specified as a cellZone.  Current "
+            << "The MRF region must be specified as a cellZone. Current "
             << "selection mode is " << selectionModeTypeNames_[selectionMode_]
             << exit(FatalError);
     }
diff --git a/src/lagrangian/Allwmake b/src/lagrangian/Allwmake
index a4be085658abaefd479e1d9714cb54b165df949e..5310b3c87f500225fef81d026411b891b5335f0f 100755
--- a/src/lagrangian/Allwmake
+++ b/src/lagrangian/Allwmake
@@ -7,6 +7,7 @@ wmake $makeType distributionModels
 wmake $makeType basic
 wmake $makeType solidParticle
 wmake $makeType intermediate
+wmake $makeType turbulence
 wmake $makeType spray
 wmake $makeType dsmc
 wmake $makeType coalCombustion
diff --git a/src/lagrangian/basic/Cloud/Cloud.C b/src/lagrangian/basic/Cloud/Cloud.C
index c0e43c168689465eae3c8a48aceb503c26ca9733..3773de6606c3b8668169511400d4527221d77dec 100644
--- a/src/lagrangian/basic/Cloud/Cloud.C
+++ b/src/lagrangian/basic/Cloud/Cloud.C
@@ -219,22 +219,33 @@ void Foam::Cloud<ParticleType>::move(TrackData& td, const scalar trackTime)
     // Reset nTrackingRescues
     nTrackingRescues_ = 0;
 
+
+    // List of lists of particles to be transfered for all of the
+    // neighbour processors
+    List<IDLList<ParticleType> > particleTransferLists
+    (
+        neighbourProcs.size()
+    );
+
+    // List of destination processorPatches indices for all of the
+    // neighbour processors
+    List<DynamicList<label> > patchIndexTransferLists
+    (
+        neighbourProcs.size()
+    );
+
+    // Allocate transfer buffers
+    PstreamBuffers pBufs(Pstream::nonBlocking);
+
+
     // While there are particles to transfer
     while (true)
     {
-        // List of lists of particles to be transfered for all of the
-        // neighbour processors
-        List<IDLList<ParticleType> > particleTransferLists
-        (
-            neighbourProcs.size()
-        );
-
-        // List of destination processorPatches indices for all of the
-        // neighbour processors
-        List<DynamicList<label> > patchIndexTransferLists
-        (
-            neighbourProcs.size()
-        );
+        particleTransferLists = IDLList<ParticleType>();
+        forAll(patchIndexTransferLists, i)
+        {
+            patchIndexTransferLists[i].clear();
+        }
 
         // Loop over all particles
         forAllIter(typename Cloud<ParticleType>, *this, pIter)
@@ -288,8 +299,9 @@ void Foam::Cloud<ParticleType>::move(TrackData& td, const scalar trackTime)
             break;
         }
 
-        // Allocate transfer buffers
-        PstreamBuffers pBufs(Pstream::nonBlocking);
+
+        // Clear transfer buffers
+        pBufs.clear();
 
         // Stream into send buffers
         forAll(particleTransferLists, i)
@@ -308,12 +320,12 @@ void Foam::Cloud<ParticleType>::move(TrackData& td, const scalar trackTime)
             }
         }
 
-        // Set up transfers when in non-blocking mode. Returns sizes (in bytes)
-        // to be sent/received.
-        labelListList allNTrans(Pstream::nProcs());
 
+        // Start sending. Sets number of bytes transferred
+        labelListList allNTrans(Pstream::nProcs());
         pBufs.finishedSends(allNTrans);
 
+
         bool transfered = false;
 
         forAll(allNTrans, i)
diff --git a/src/lagrangian/coalCombustion/Make/options b/src/lagrangian/coalCombustion/Make/options
index 0d7eb0e13ba648b92847e780c1bed3fa70b8e7c2..b69da4c94fc3c5552ccdafac9c3a11241858134a 100644
--- a/src/lagrangian/coalCombustion/Make/options
+++ b/src/lagrangian/coalCombustion/Make/options
@@ -24,6 +24,7 @@ LIB_LIBS = \
     -lmeshTools \
     -llagrangian \
     -llagrangianIntermediate \
+    -llagrangianTurbulence \
     -ldistributionModels \
     -lspecie \
     -lfluidThermophysicalModels \
diff --git a/src/lagrangian/intermediate/Make/files b/src/lagrangian/intermediate/Make/files
index 6d4e26a441dcd9f13941acab665720065132887d..9cadf55117b49ed1c79380a9e37e213b68a2acf7 100644
--- a/src/lagrangian/intermediate/Make/files
+++ b/src/lagrangian/intermediate/Make/files
@@ -19,6 +19,8 @@ KINEMATICPARCEL=$(DERIVEDPARCELS)/basicKinematicParcel
 $(KINEMATICPARCEL)/defineBasicKinematicParcel.C
 $(KINEMATICPARCEL)/makeBasicKinematicParcelSubmodels.C
 
+
+/* kinematic colliding parcel sub-models */
 KINEMATICCOLLIDINGPARCEL=$(DERIVEDPARCELS)/basicKinematicCollidingParcel
 $(KINEMATICCOLLIDINGPARCEL)/defineBasicKinematicCollidingParcel.C
 $(KINEMATICCOLLIDINGPARCEL)/makeBasicKinematicCollidingParcelSubmodels.C
@@ -42,6 +44,12 @@ $(REACTINGMPPARCEL)/defineBasicReactingMultiphaseParcel.C
 $(REACTINGMPPARCEL)/makeBasicReactingMultiphaseParcelSubmodels.C
 
 
+/* kinematic MPPIC parcel sub-models */
+KINEMATICMPPICPARCEL=$(DERIVEDPARCELS)/basicKinematicMPPICParcel
+$(KINEMATICMPPICPARCEL)/defineBasicKinematicMPPICParcel.C
+$(KINEMATICMPPICPARCEL)/makeBasicKinematicMPPICParcelSubmodels.C
+
+
 /* bolt-on models */
 RADIATION=submodels/addOns/radiation
 $(RADIATION)/absorptionEmission/cloudAbsorptionEmission/cloudAbsorptionEmission.C
@@ -71,6 +79,24 @@ $(REACTINGMPINJECTION)/ReactingMultiphaseLookupTableInjection/reactingMultiphase
 $(REACTINGMPINJECTION)/ReactingMultiphaseLookupTableInjection/reactingMultiphaseParcelInjectionDataIO.C
 $(REACTINGMPINJECTION)/ReactingMultiphaseLookupTableInjection/reactingMultiphaseParcelInjectionDataIOList.C
 
+MPPICPARTICLESTRESS=submodels/MPPIC/ParticleStressModels
+$(MPPICPARTICLESTRESS)/ParticleStressModel/ParticleStressModel.C
+$(MPPICPARTICLESTRESS)/HarrisCrighton/HarrisCrighton.C
+$(MPPICPARTICLESTRESS)/Lun/Lun.C
+$(MPPICPARTICLESTRESS)/exponential/exponential.C
+
+MPPICCORRECTIONLIMITING=submodels/MPPIC/CorrectionLimitingMethods
+$(MPPICCORRECTIONLIMITING)/CorrectionLimitingMethod/CorrectionLimitingMethod.C
+$(MPPICCORRECTIONLIMITING)/noCorrectionLimiting/noCorrectionLimiting.C
+$(MPPICCORRECTIONLIMITING)/absolute/absolute.C
+$(MPPICCORRECTIONLIMITING)/relative/relative.C
+
+MPPICTIMESCALE=submodels/MPPIC/TimeScaleModels
+$(MPPICTIMESCALE)/TimeScaleModel/TimeScaleModel.C
+$(MPPICTIMESCALE)/equilibrium/equilibrium.C
+$(MPPICTIMESCALE)/nonEquilibrium/nonEquilibrium.C
+$(MPPICTIMESCALE)/isotropic/isotropic.C
+
 
 /* integration schemes */
 IntegrationScheme/makeIntegrationSchemes.C
@@ -81,8 +107,13 @@ phaseProperties/phaseProperties/phaseProperties.C
 phaseProperties/phaseProperties/phasePropertiesIO.C
 phaseProperties/phasePropertiesList/phasePropertiesList.C
 
-/* Additional helper classes */
+
+/* additional helper classes */
 clouds/Templates/KinematicCloud/cloudSolution/cloudSolution.C
 
 
+/* averaging methods */
+submodels/MPPIC/AveragingMethods/makeAveragingMethods.C
+
+
 LIB = $(FOAM_LIBBIN)/liblagrangianIntermediate
diff --git a/src/lagrangian/intermediate/Make/options b/src/lagrangian/intermediate/Make/options
index f4e774028ee458a334ce664a39deecb2ca0aff55..79cbc346255fa00a82724a0afa228787f9d334b7 100644
--- a/src/lagrangian/intermediate/Make/options
+++ b/src/lagrangian/intermediate/Make/options
@@ -12,7 +12,6 @@ EXE_INC = \
     -I$(LIB_SRC)/thermophysicalModels/reactionThermo/lnInclude \
     -I$(LIB_SRC)/thermophysicalModels/SLGThermo/lnInclude \
     -I$(LIB_SRC)/thermophysicalModels/radiationModels/lnInclude \
-    -I$(LIB_SRC)/turbulenceModels \
     -I$(LIB_SRC)/transportModels \
     -I$(LIB_SRC)/regionModels/regionModel/lnInclude \
     -I$(LIB_SRC)/regionModels/surfaceFilmModels/lnInclude \
@@ -33,13 +32,6 @@ LIB_LIBS = \
     -lreactionThermophysicalModels \
     -lSLGThermo \
     -lradiationModels \
-    -lincompressibleTurbulenceModel \
-    -lincompressibleRASModels \
-    -lincompressibleLESModels \
-    -lcompressibleTurbulenceModel \
-    -lcompressibleRASModels \
-    -lcompressibleLESModels \
-    -lLESdeltas \
     -lincompressibleTransportModels \
     -lregionModels \
     -lsurfaceFilmModels \
diff --git a/src/lagrangian/intermediate/clouds/Templates/MPPICCloud/MPPICCloud.C b/src/lagrangian/intermediate/clouds/Templates/MPPICCloud/MPPICCloud.C
new file mode 100644
index 0000000000000000000000000000000000000000..f22cac7b0ff559a1e8b970c9a49060e03a4b58ae
--- /dev/null
+++ b/src/lagrangian/intermediate/clouds/Templates/MPPICCloud/MPPICCloud.C
@@ -0,0 +1,299 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "MPPICCloud.H"
+#include "PackingModel.H"
+#include "ParticleStressModel.H"
+#include "DampingModel.H"
+#include "IsotropyModel.H"
+#include "TimeScaleModel.H"
+
+// * * * * * * * * * * * * * Protected Member Functions  * * * * * * * * * * //
+
+template<class CloudType>
+void Foam::MPPICCloud<CloudType>::setModels()
+{
+    packingModel_.reset
+    (
+        PackingModel<MPPICCloud<CloudType> >::New
+        (
+            this->subModelProperties(),
+            *this
+        ).ptr()
+    );
+    dampingModel_.reset
+    (
+        DampingModel<MPPICCloud<CloudType> >::New
+        (
+            this->subModelProperties(),
+            *this
+        ).ptr()
+    );
+    isotropyModel_.reset
+    (
+        IsotropyModel<MPPICCloud<CloudType> >::New
+        (
+            this->subModelProperties(),
+            *this
+        ).ptr()
+    );
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::MPPICCloud<CloudType>::MPPICCloud
+(
+    const word& cloudName,
+    const volScalarField& rho,
+    const volVectorField& U,
+    const volScalarField& mu,
+    const dimensionedVector& g,
+    bool readFields
+)
+:
+    CloudType(cloudName, rho, U, mu, g, false),
+    packingModel_(NULL),
+    dampingModel_(NULL),
+    isotropyModel_(NULL)
+{
+    if (this->solution().steadyState())
+    {
+        FatalErrorIn
+        (
+            "Foam::MPPICCloud<CloudType>::MPPICCloud"
+            "("
+                "const word&, "
+                "const volScalarField&, "
+                "const volVectorField&, "
+                "const volScalarField&, "
+                "const dimensionedVector&, "
+                "bool"
+            ")"
+        )   << "MPPIC modelling not available for steady state calculations"
+            << exit(FatalError);
+    }
+
+    if (this->solution().active())
+    {
+        setModels();
+
+        if (readFields)
+        {
+            parcelType::readFields(*this);
+        }
+    }
+}
+
+
+template<class CloudType>
+Foam::MPPICCloud<CloudType>::MPPICCloud
+(
+    MPPICCloud<CloudType>& c,
+    const word& name
+)
+:
+    CloudType(c, name),
+    packingModel_(c.packingModel_->clone()),
+    dampingModel_(c.dampingModel_->clone()),
+    isotropyModel_(c.isotropyModel_->clone())
+{}
+
+
+template<class CloudType>
+Foam::MPPICCloud<CloudType>::MPPICCloud
+(
+    const fvMesh& mesh,
+    const word& name,
+    const MPPICCloud<CloudType>& c
+)
+:
+    CloudType(mesh, name, c),
+    packingModel_(NULL),
+    dampingModel_(NULL),
+    isotropyModel_(NULL)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::MPPICCloud<CloudType>::~MPPICCloud()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class CloudType>
+void Foam::MPPICCloud<CloudType>::storeState()
+{
+    cloudCopyPtr_.reset
+    (
+        static_cast<MPPICCloud<CloudType>*>
+        (
+            clone(this->name() + "Copy").ptr()
+        )
+    );
+}
+
+
+template<class CloudType>
+void Foam::MPPICCloud<CloudType>::restoreState()
+{
+    this->cloudReset(cloudCopyPtr_());
+    cloudCopyPtr_.clear();
+}
+
+
+template<class CloudType>
+void Foam::MPPICCloud<CloudType>::evolve()
+{
+    if (this->solution().canEvolve())
+    {
+        typename parcelType::template
+            TrackingData<MPPICCloud<CloudType> > td(*this);
+
+        this->solve(td);
+    }
+}
+
+
+template<class CloudType>
+template<class TrackData>
+void Foam::MPPICCloud<CloudType>::motion(TrackData& td)
+{
+    // Kinematic
+    // ~~~~~~~~~
+
+    // force calculation and tracking
+    td.part() = TrackData::tpLinearTrack;
+    CloudType::move(td, this->db().time().deltaTValue());
+
+
+    // Preliminary
+    // ~~~~~~~~~~~
+
+    // switch forces off so they are not applied in corrector steps
+    this->forces().setCalcNonCoupled(false);
+    this->forces().setCalcCoupled(false);
+
+
+    // Damping
+    // ~~~~~~~
+
+    if (dampingModel_->active())
+    {
+        // update averages
+        td.updateAverages(*this);
+
+        // memory allocation and eulerian calculations
+        dampingModel_->cacheFields(true);
+
+        // calculate the damping velocity corrections without moving the parcels
+        td.part() = TrackData::tpDampingNoTrack;
+        CloudType::move(td, this->db().time().deltaTValue());
+
+        // correct the parcel positions and velocities
+        td.part() = TrackData::tpCorrectTrack;
+        CloudType::move(td, this->db().time().deltaTValue());
+
+        // finalise and free memory
+        dampingModel_->cacheFields(false);
+    }
+
+
+    // Packing
+    // ~~~~~~~
+
+    if (packingModel_->active())
+    {
+        // same procedure as for damping
+        td.updateAverages(*this);
+        packingModel_->cacheFields(true);
+        td.part() = TrackData::tpPackingNoTrack;
+        CloudType::move(td, this->db().time().deltaTValue());
+        td.part() = TrackData::tpCorrectTrack;
+        CloudType::move(td, this->db().time().deltaTValue());
+        packingModel_->cacheFields(false);
+    }
+
+
+    // Isotropy
+    // ~~~~~~~~
+
+    if (isotropyModel_->active())
+    {
+        // update averages
+        td.updateAverages(*this);
+
+        // apply isotropy model
+        isotropyModel_->calculate();
+    }
+
+
+    // Final
+    // ~~~~~
+
+    // update cell occupancy
+    this->updateCellOccupancy();
+
+    // switch forces back on
+    this->forces().setCalcNonCoupled(true);
+    this->forces().setCalcCoupled(this->solution().coupled());
+}
+
+
+template<class CloudType>
+void Foam::MPPICCloud<CloudType>::info()
+{
+    CloudType::info();
+
+    tmp<volScalarField> alpha = this->theta();
+
+    Info<< "    Min cell volume fraction        = "
+        << gMin(alpha().internalField()) << endl;
+    Info<< "    Max cell volume fraction        = "
+        << gMax(alpha().internalField()) << endl;
+
+    label nOutside = 0;
+
+    forAllIter(typename CloudType, *this, iter)
+    {
+        typename CloudType::parcelType& p = iter();
+        const tetIndices tetIs(p.cell(), p.tetFace(), p.tetPt(), this->mesh());
+        nOutside += !tetIs.tet(this->mesh()).inside(p.position());
+    }
+
+    reduce(nOutside, plusOp<label>());
+
+    if (nOutside > 0)
+    {
+        Info<< "    Number of parcels outside tets  = " << nOutside << endl;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/clouds/Templates/MPPICCloud/MPPICCloud.H b/src/lagrangian/intermediate/clouds/Templates/MPPICCloud/MPPICCloud.H
new file mode 100644
index 0000000000000000000000000000000000000000..8583f6b73972ee994cba68911987c9352a6e507a
--- /dev/null
+++ b/src/lagrangian/intermediate/clouds/Templates/MPPICCloud/MPPICCloud.H
@@ -0,0 +1,249 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::MPPICCloud
+
+Description
+    Adds MPPIC modelling to kinematic clouds
+
+SourceFiles
+    MPPICCloudI.H
+    MPPICCloud.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef MPPICCloud_H
+#define MPPICCloud_H
+
+#include "particle.H"
+#include "Cloud.H"
+#include "IOdictionary.H"
+#include "autoPtr.H"
+#include "fvMesh.H"
+#include "volFields.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+// Forward declaration of classes
+
+template<class CloudType>
+class PackingModel;
+
+template<class CloudType>
+class DampingModel;
+
+template<class CloudType>
+class IsotropyModel;
+
+/*---------------------------------------------------------------------------*\
+                       Class MPPICCloud Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class CloudType>
+class MPPICCloud
+:
+    public CloudType
+{
+public:
+
+    // Public typedefs
+
+        //- Type of cloud this cloud was instantiated for
+        typedef CloudType cloudType;
+
+        //- Type of parcel the cloud was instantiated for
+        typedef typename CloudType::parcelType parcelType;
+
+        //- Convenience typedef for this cloud type
+        typedef MPPICCloud<CloudType> MPPICCloudType;
+
+
+private:
+
+    // Private data
+
+        //- Cloud copy pointer
+        autoPtr<MPPICCloud<CloudType> > cloudCopyPtr_;
+
+
+    // Private Member Functions
+
+        //- Disallow default bitwise copy construct
+        MPPICCloud(const MPPICCloud&);
+
+        //- Disallow default bitwise assignment
+        void operator=(const MPPICCloud&);
+
+
+protected:
+
+    // Protected data
+
+        // References to the cloud sub-models
+
+            //- Packing model
+            autoPtr<PackingModel<MPPICCloud<CloudType> > > packingModel_;
+
+            //- Damping model
+            autoPtr<DampingModel<MPPICCloud<CloudType> > >
+                dampingModel_;
+
+            //- Exchange model
+            autoPtr<IsotropyModel<MPPICCloud<CloudType> > >
+                isotropyModel_;
+
+
+        // Initialisation
+
+            //- Set cloud sub-models
+            void setModels();
+
+
+public:
+
+    // Constructors
+
+        //- Construct given carrier gas fields
+        MPPICCloud
+        (
+            const word& cloudName,
+            const volScalarField& rho,
+            const volVectorField& U,
+            const volScalarField& mu,
+            const dimensionedVector& g,
+            bool readFields = true
+        );
+
+        //- Copy constructor with new name
+        MPPICCloud
+        (
+            MPPICCloud<CloudType>& c,
+            const word& name
+        );
+
+        //- Copy constructor with new name - creates bare cloud
+        MPPICCloud
+        (
+            const fvMesh& mesh,
+            const word& name,
+            const MPPICCloud<CloudType>& c
+        );
+
+        //- Construct and return clone based on (this) with new name
+        virtual autoPtr<Cloud<parcelType> > clone(const word& name)
+        {
+            return autoPtr<Cloud<parcelType> >
+            (
+                new MPPICCloud(*this, name)
+            );
+        }
+
+        //- Construct and return bare clone based on (this) with new name
+        virtual autoPtr<Cloud<parcelType> > cloneBare(const word& name) const
+        {
+            return autoPtr<Cloud<parcelType> >
+            (
+                new MPPICCloud(this->mesh(), name, *this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~MPPICCloud();
+
+
+    // Member Functions
+
+        // Access
+
+            //- Return a reference to the cloud copy
+            inline const MPPICCloud& cloudCopy() const;
+
+            //- Return const access to the packing model
+            inline const PackingModel<MPPICCloud<CloudType> >&
+                packingModel() const;
+
+            //- Return a reference to the packing model
+            inline PackingModel<MPPICCloud<CloudType> >& packingModel();
+
+            //- Return condt access to the damping model
+            inline const DampingModel<MPPICCloud<CloudType> >&
+                dampingModel() const;
+
+            //- Return a reference to the damping model
+            inline DampingModel<MPPICCloud<CloudType> >& dampingModel();
+
+            //- Return condt access to the isotropy model
+            inline const IsotropyModel<MPPICCloud<CloudType> >&
+                isotropyModel() const;
+
+            //- Return a reference to the isotropy model
+            inline IsotropyModel<MPPICCloud<CloudType> >& isotropyModel();
+
+
+        // Cloud evolution functions
+
+            //- Store the current cloud state
+            void storeState();
+
+            //- Reset the current cloud to the previously stored state
+            void restoreState();
+
+            //- Evolve the cloud
+            void evolve();
+
+            //- Particle motion
+            template<class TrackData>
+            void motion(TrackData& td);
+
+
+        //- I-O
+
+            //- Print cloud information
+            void info();
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#include "MPPICCloudI.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "MPPICCloud.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/clouds/Templates/MPPICCloud/MPPICCloudI.H b/src/lagrangian/intermediate/clouds/Templates/MPPICCloud/MPPICCloudI.H
new file mode 100644
index 0000000000000000000000000000000000000000..5211f8700276135f180f91122d98ba7c46cbd4de
--- /dev/null
+++ b/src/lagrangian/intermediate/clouds/Templates/MPPICCloud/MPPICCloudI.H
@@ -0,0 +1,84 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class CloudType>
+inline const Foam::MPPICCloud<CloudType>&
+Foam::MPPICCloud<CloudType>::cloudCopy() const
+{
+    return cloudCopyPtr_();
+}
+
+
+template<class CloudType>
+inline const Foam::PackingModel<Foam::MPPICCloud<CloudType> >&
+Foam::MPPICCloud<CloudType>::packingModel() const
+{
+    return packingModel_();
+}
+
+
+template<class CloudType>
+inline Foam::PackingModel<Foam::MPPICCloud<CloudType> >&
+Foam::MPPICCloud<CloudType>::packingModel()
+{
+    return packingModel_();
+}
+
+
+template<class CloudType>
+inline const Foam::DampingModel<Foam::MPPICCloud<CloudType> >&
+Foam::MPPICCloud<CloudType>::dampingModel() const
+{
+    return dampingModel_();
+}
+
+
+template<class CloudType>
+inline Foam::DampingModel<Foam::MPPICCloud<CloudType> >&
+Foam::MPPICCloud<CloudType>::dampingModel()
+{
+    return dampingModel_();
+}
+
+
+template<class CloudType>
+inline const Foam::IsotropyModel<Foam::MPPICCloud<CloudType> >&
+Foam::MPPICCloud<CloudType>::isotropyModel() const
+{
+    return isotropyModel_();
+}
+
+
+template<class CloudType>
+inline Foam::IsotropyModel<Foam::MPPICCloud<CloudType> >&
+Foam::MPPICCloud<CloudType>::isotropyModel()
+{
+    return isotropyModel_();
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/clouds/derived/basicKinematicMPPICCloud/basicKinematicMPPICCloud.H b/src/lagrangian/intermediate/clouds/derived/basicKinematicMPPICCloud/basicKinematicMPPICCloud.H
new file mode 100644
index 0000000000000000000000000000000000000000..e239b0606fbe39a7b47a8dfa2eef20c93a295252
--- /dev/null
+++ b/src/lagrangian/intermediate/clouds/derived/basicKinematicMPPICCloud/basicKinematicMPPICCloud.H
@@ -0,0 +1,60 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::basicKinematicMPPICCloud
+
+Description
+    Cloud class to introduce kinematic MPPIC parcels
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef basicKinematicMPPICCloud_H
+#define basicKinematicMPPICCloud_H
+
+#include "Cloud.H"
+#include "KinematicCloud.H"
+#include "MPPICCloud.H"
+#include "basicKinematicMPPICParcel.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    typedef MPPICCloud
+    <
+        KinematicCloud
+        <
+            Cloud
+            <
+                basicKinematicMPPICParcel
+            >
+        >
+    > basicKinematicMPPICCloud;
+}
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/parcels/Templates/CollidingParcel/CollidingParcel.C b/src/lagrangian/intermediate/parcels/Templates/CollidingParcel/CollidingParcel.C
index f422f7ea372fc1c9904125e6b01e1fe2de8362e5..36f146d77af4e7892309ec000bc70512c76e925a 100644
--- a/src/lagrangian/intermediate/parcels/Templates/CollidingParcel/CollidingParcel.C
+++ b/src/lagrangian/intermediate/parcels/Templates/CollidingParcel/CollidingParcel.C
@@ -80,6 +80,8 @@ bool Foam::CollidingParcel<ParcelType>::move
 
             p.angularMomentum() += 0.5*trackTime*p.torque();
 
+            td.keepParticle = true;
+
             break;
         }
 
diff --git a/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcel.C b/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcel.C
new file mode 100644
index 0000000000000000000000000000000000000000..0bac21bf8f3d6d5120217f93ff27ac229f6df848
--- /dev/null
+++ b/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcel.C
@@ -0,0 +1,116 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "MPPICParcel.H"
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class ParcelType>
+Foam::MPPICParcel<ParcelType>::MPPICParcel
+(
+    const MPPICParcel<ParcelType>& p
+)
+:
+    ParcelType(p),
+    UCorrect_(p.UCorrect_)
+{}
+
+
+template<class ParcelType>
+Foam::MPPICParcel<ParcelType>::MPPICParcel
+(
+    const MPPICParcel<ParcelType>& p,
+    const polyMesh& mesh
+)
+:
+    ParcelType(p, mesh),
+    UCorrect_(p.UCorrect_)
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class ParcelType>
+template<class TrackData>
+bool Foam::MPPICParcel<ParcelType>::move
+(
+    TrackData& td,
+    const scalar trackTime
+)
+{
+    typename TrackData::cloudType::parcelType& p =
+        static_cast<typename TrackData::cloudType::parcelType&>(*this);
+
+    switch (td.part())
+    {
+        case TrackData::tpLinearTrack:
+        {
+            ParcelType::move(td, trackTime);
+
+            break;
+        }
+        case TrackData::tpDampingNoTrack:
+        {
+            p.UCorrect() =
+                td.cloud().dampingModel().velocityCorrection(p, trackTime);
+
+            td.keepParticle = true;
+
+            break;
+        }
+        case TrackData::tpPackingNoTrack:
+        {
+            p.UCorrect() =
+                td.cloud().packingModel().velocityCorrection(p, trackTime);
+
+            td.keepParticle = true;
+
+            break;
+        }
+        case TrackData::tpCorrectTrack:
+        {
+            vector U = p.U();
+
+            scalar f = p.stepFraction();
+
+            p.U() = (1.0 - f)*p.UCorrect();
+
+            ParcelType::move(td, trackTime);
+
+            p.U() = U + (p.stepFraction() - f)*p.UCorrect();
+
+            break;
+        }
+    }
+
+    return td.keepParticle;
+}
+
+
+// * * * * * * * * * * * * * * IOStream operators  * * * * * * * * * * * * * //
+
+#include "MPPICParcelIO.C"
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcel.H b/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcel.H
new file mode 100644
index 0000000000000000000000000000000000000000..c095821f8da77d59cb25cc09a437cdb308afc44e
--- /dev/null
+++ b/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcel.H
@@ -0,0 +1,315 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::MPPICParcel
+
+Description
+    Wrapper around kinematic parcel types to add MPPIC modelling
+
+SourceFiles
+    MPPICParcelI.H
+    MPPICParcelTrackingDataI.H
+    MPPICParcel.C
+    MPPICParcelIO.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef MPPICParcel_H
+#define MPPICParcel_H
+
+#include "particle.H"
+#include "labelFieldIOField.H"
+#include "vectorFieldIOField.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+// Forward declaration of clases
+
+template<class ParcelType>
+class MPPICParcel;
+
+template<class Type>
+class AveragingMethod;
+
+// Forward declaration of friend functions
+
+template<class ParcelType>
+Ostream& operator<<
+(
+    Ostream&,
+    const MPPICParcel<ParcelType>&
+);
+
+/*---------------------------------------------------------------------------*\
+                       Class MPPICParcel Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class ParcelType>
+class MPPICParcel
+:
+    public ParcelType
+{
+public:
+
+    template<class CloudType>
+    class TrackingData
+    :
+        public ParcelType::template TrackingData<CloudType>
+    {
+
+    public:
+
+        enum trackPart
+        {
+            tpLinearTrack,
+            tpDampingNoTrack,
+            tpPackingNoTrack,
+            tpCorrectTrack,
+        };
+
+
+    private:
+
+        // Private data
+
+            // MPPIC Averages
+
+                //- Volume average
+                autoPtr<AveragingMethod<scalar> > volumeAverage_;
+
+                //- Radius average [ volume^(1/3) ]
+                autoPtr<AveragingMethod<scalar> > radiusAverage_;
+
+                //- Density average
+                autoPtr<AveragingMethod<scalar> > rhoAverage_;
+
+                //- Velocity average
+                autoPtr<AveragingMethod<vector> > uAverage_;
+
+                //- Magnitude velocity sqyuared average
+                autoPtr<AveragingMethod<scalar> > uSqrAverage_;
+
+                //- Frequency average
+                autoPtr<AveragingMethod<scalar> > frequencyAverage_;
+
+                //- Mass average
+                autoPtr<AveragingMethod<scalar> > massAverage_;
+
+
+            //- Label specifying the current part of the tracking process
+            trackPart part_;
+
+
+    public:
+
+        //- Constructors
+
+            //- Construct from components
+            inline TrackingData
+            (
+                CloudType& cloud,
+                trackPart part = tpLinearTrack
+            );
+
+
+        //- Update the MPPIC averages
+        inline void updateAverages(CloudType& cloud);
+
+
+        //- Access
+
+            //- Const access to the tracking part label
+            inline trackPart part() const;
+
+            //- Non const access to the tracking part label
+            inline trackPart& part();
+    };
+
+
+protected:
+
+    // Protected data
+
+        //- Velocity correction due to collisions [m/s]
+        vector UCorrect_;
+
+
+public:
+
+    // Static data members
+
+        //- Runtime type information
+        TypeName("MPPICParcel");
+
+        //- String representation of properties
+        AddToPropertyList
+        (
+            ParcelType,
+            "(UCorrectx UCorrecty UCorrectz)"
+        );
+
+
+    // Constructors
+
+        //- Construct from owner, position, and cloud owner
+        //  Other properties initialised as null
+        inline MPPICParcel
+        (
+            const polyMesh& mesh,
+            const vector& position,
+            const label cellI,
+            const label tetFaceI,
+            const label tetPtI
+        );
+
+        //- Construct from components
+        inline MPPICParcel
+        (
+            const polyMesh& mesh,
+            const vector& position,
+            const label cellI,
+            const label tetFaceI,
+            const label tetPtI,
+            const label typeId,
+            const scalar nParticle0,
+            const scalar d0,
+            const scalar dTarget0,
+            const vector& U0,
+            const vector& UCorrect0,
+            const typename ParcelType::constantProperties& constProps
+        );
+
+        //- Construct from Istream
+        MPPICParcel
+        (
+            const polyMesh& mesh,
+            Istream& is,
+            bool readFields = true
+        );
+
+        //- Construct as a copy
+        MPPICParcel(const MPPICParcel& p);
+
+        //- Construct as a copy
+        MPPICParcel(const MPPICParcel& p, const polyMesh& mesh);
+
+        //- Construct and return a (basic particle) clone
+        virtual autoPtr<particle> clone() const
+        {
+            return autoPtr<particle>(new MPPICParcel(*this));
+        }
+
+        //- Construct and return a (basic particle) clone
+        virtual autoPtr<particle> clone(const polyMesh& mesh) const
+        {
+            return autoPtr<particle>(new MPPICParcel(*this, mesh));
+        }
+
+        //- Factory class to read-construct particles used for
+        //  parallel transfer
+        class iNew
+        {
+            const polyMesh& mesh_;
+
+        public:
+
+            iNew(const polyMesh& mesh)
+            :
+                mesh_(mesh)
+            {}
+
+            autoPtr<MPPICParcel<ParcelType> > operator()(Istream& is) const
+            {
+                return autoPtr<MPPICParcel<ParcelType> >
+                (
+                    new MPPICParcel<ParcelType>(mesh_, is, true)
+                );
+            }
+        };
+
+
+    // Member Functions
+
+        // Access
+
+            //- Return const access to correction velocity
+            inline const vector& UCorrect() const;
+
+            //- Return access to correction velocity
+            inline vector& UCorrect();
+
+
+        // Tracking
+
+            //- Move the parcel
+            template<class TrackData>
+            bool move(TrackData& td, const scalar trackTime);
+
+
+    // Friend Functions
+
+        // I-O
+
+            //- Read
+            template<class CloudType>
+            static void readFields(CloudType& c);
+
+            //- Write
+            template<class CloudType>
+            static void writeFields(const CloudType& c);
+
+
+        // Ostream operator
+
+            friend Ostream& operator<< <ParcelType>
+            (
+                Ostream&,
+                const MPPICParcel<ParcelType>&
+            );
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#include "MPPICParcelI.H"
+#include "MPPICParcelTrackingDataI.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+    #include "MPPICParcel.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcelI.H b/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcelI.H
new file mode 100644
index 0000000000000000000000000000000000000000..ab01a6421d0d1df011c253368faaab6411ab2fe5
--- /dev/null
+++ b/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcelI.H
@@ -0,0 +1,94 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class ParcelType>
+inline Foam::MPPICParcel<ParcelType>::MPPICParcel
+(
+    const polyMesh& owner,
+    const vector& position,
+    const label cellI,
+    const label tetFaceI,
+    const label tetPtI
+)
+:
+    ParcelType(owner, position, cellI, tetFaceI, tetPtI),
+    UCorrect_(vector::zero)
+{}
+
+
+template<class ParcelType>
+inline Foam::MPPICParcel<ParcelType>::MPPICParcel
+(
+    const polyMesh& owner,
+    const vector& position,
+    const label cellI,
+    const label tetFaceI,
+    const label tetPtI,
+    const label typeId,
+    const scalar nParticle0,
+    const scalar d0,
+    const scalar dTarget0,
+    const vector& U0,
+    const vector& UCorrect0,
+    const typename ParcelType::constantProperties& constProps
+)
+:
+    ParcelType
+    (
+        owner,
+        position,
+        cellI,
+        tetFaceI,
+        tetPtI,
+        typeId,
+        nParticle0,
+        d0,
+        dTarget0,
+        U0,
+        constProps
+    ),
+    UCorrect_(UCorrect0)
+{}
+
+
+// * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * * //
+
+template<class ParcelType>
+inline const Foam::vector& Foam::MPPICParcel<ParcelType>::UCorrect() const
+{
+    return UCorrect_;
+}
+
+
+template<class ParcelType>
+inline Foam::vector& Foam::MPPICParcel<ParcelType>::UCorrect()
+{
+    return UCorrect_;
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcelIO.C b/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcelIO.C
new file mode 100644
index 0000000000000000000000000000000000000000..f0eff872b0df43b16eb906f39c3abc6f791e4658
--- /dev/null
+++ b/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcelIO.C
@@ -0,0 +1,160 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "MPPICParcel.H"
+#include "IOstreams.H"
+#include "IOField.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+template<class ParcelType>
+Foam::string Foam::MPPICParcel<ParcelType>::propertyList_ =
+    Foam::MPPICParcel<ParcelType>::propertyList();
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class ParcelType>
+Foam::MPPICParcel<ParcelType>::MPPICParcel
+(
+    const polyMesh& mesh,
+    Istream& is,
+    bool readFields
+)
+:
+    ParcelType(mesh, is, readFields),
+    UCorrect_(vector::zero)
+{
+    if (readFields)
+    {
+        if (is.format() == IOstream::ASCII)
+        {
+            is >> UCorrect_;
+        }
+        else
+        {
+            is.read
+            (
+                reinterpret_cast<char*>(&UCorrect_),
+              + sizeof(UCorrect_)
+            );
+        }
+    }
+
+    is.check
+    (
+        "MPPICParcel<ParcelType>::Collisions"
+        "(const polyMesh&, Istream&, bool)"
+    );
+}
+
+
+template<class ParcelType>
+template<class CloudType>
+void Foam::MPPICParcel<ParcelType>::readFields(CloudType& c)
+{
+    if (!c.size())
+    {
+        return;
+    }
+
+    ParcelType::readFields(c);
+
+    IOField<vector> UCorrect(c.fieldIOobject("UCorrect", IOobject::MUST_READ));
+    c.checkFieldIOobject(c, UCorrect);
+
+    label i = 0;
+
+    forAllIter(typename CloudType, c, iter)
+    {
+        MPPICParcel<ParcelType>& p = iter();
+
+        p.UCorrect_ = UCorrect[i];
+
+        i++;
+    }
+}
+
+
+template<class ParcelType>
+template<class CloudType>
+void Foam::MPPICParcel<ParcelType>::writeFields(const CloudType& c)
+{
+    ParcelType::writeFields(c);
+
+    label np =  c.size();
+
+    IOField<vector>
+        UCorrect(c.fieldIOobject("UCorrect", IOobject::NO_READ), np);
+
+    label i = 0;
+
+    forAllConstIter(typename CloudType, c, iter)
+    {
+        const MPPICParcel<ParcelType>& p = iter();
+
+        UCorrect[i] = p.UCorrect();
+
+        i++;
+    }
+
+    UCorrect.write();
+}
+
+
+// * * * * * * * * * * * * * * * IOstream Operators  * * * * * * * * * * * * //
+
+template<class ParcelType>
+Foam::Ostream& Foam::operator<<
+(
+    Ostream& os,
+    const MPPICParcel<ParcelType>& p
+)
+{
+    if (os.format() == IOstream::ASCII)
+    {
+        os  << static_cast<const ParcelType&>(p)
+            << token::SPACE << p.UCorrect();
+    }
+    else
+    {
+        os  << static_cast<const ParcelType&>(p);
+        os.write
+        (
+            reinterpret_cast<const char*>(&p.UCorrect_),
+          + sizeof(p.UCorrect())
+        );
+    }
+
+    os.check
+    (
+        "Ostream& operator<<(Ostream&, const MPPICParcel<ParcelType>&)"
+    );
+
+    return os;
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcelTrackingDataI.H b/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcelTrackingDataI.H
new file mode 100644
index 0000000000000000000000000000000000000000..4f5edcc47e5e7398bf9ad74d9d0214b6f7d76fb7
--- /dev/null
+++ b/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcelTrackingDataI.H
@@ -0,0 +1,269 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "AveragingMethod.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+template<class ParcelType>
+template<class CloudType>
+inline Foam::MPPICParcel<ParcelType>::TrackingData<CloudType>::TrackingData
+(
+    CloudType& cloud,
+    trackPart part
+)
+:
+    ParcelType::template TrackingData<CloudType>(cloud),
+    volumeAverage_
+    (
+        AveragingMethod<scalar>::New
+        (
+            IOobject
+            (
+                cloud.name() + ":volumeAverage",
+                cloud.db().time().timeName(),
+                cloud.mesh()
+            ),
+            cloud.solution().dict(),
+            cloud.mesh()
+        )
+    ),
+    radiusAverage_
+    (
+        AveragingMethod<scalar>::New
+        (
+            IOobject
+            (
+                cloud.name() + ":radiusAverage",
+                cloud.db().time().timeName(),
+                cloud.mesh()
+            ),
+            cloud.solution().dict(),
+            cloud.mesh()
+        )
+    ),
+    rhoAverage_
+    (
+        AveragingMethod<scalar>::New
+        (
+            IOobject
+            (
+                cloud.name() + ":rhoAverage",
+                cloud.db().time().timeName(),
+                cloud.mesh()
+            ),
+            cloud.solution().dict(),
+            cloud.mesh()
+        )
+    ),
+    uAverage_
+    (
+        AveragingMethod<vector>::New
+        (
+            IOobject
+            (
+                cloud.name() + ":uAverage",
+                cloud.db().time().timeName(),
+                cloud.mesh()
+            ),
+            cloud.solution().dict(),
+            cloud.mesh()
+        )
+    ),
+    uSqrAverage_
+    (
+        AveragingMethod<scalar>::New
+        (
+            IOobject
+            (
+                cloud.name() + ":uSqrAverage",
+                cloud.db().time().timeName(),
+                cloud.mesh()
+            ),
+            cloud.solution().dict(),
+            cloud.mesh()
+        )
+    ),
+    frequencyAverage_
+    (
+        AveragingMethod<scalar>::New
+        (
+            IOobject
+            (
+                cloud.name() + ":frequencyAverage",
+                cloud.db().time().timeName(),
+                cloud.mesh()
+            ),
+            cloud.solution().dict(),
+            cloud.mesh()
+        )
+    ),
+    massAverage_
+    (
+        AveragingMethod<scalar>::New
+        (
+            IOobject
+            (
+                cloud.name() + ":massAverage",
+                cloud.db().time().timeName(),
+                cloud.mesh()
+            ),
+            cloud.solution().dict(),
+            cloud.mesh()
+        )
+    ),
+    part_(part)
+{}
+
+
+template<class ParcelType>
+template<class CloudType>
+inline void
+Foam::MPPICParcel<ParcelType>::TrackingData<CloudType>::updateAverages
+(
+    CloudType& cloud
+)
+{
+    // zero the sums
+    volumeAverage_() = 0;
+    radiusAverage_() = 0;
+    rhoAverage_() = 0;
+    uAverage_() = vector::zero;
+    uSqrAverage_() = 0;
+    frequencyAverage_() = 0;
+    massAverage_() = 0;
+
+    // temporary weights
+    autoPtr<AveragingMethod<scalar> > weightAveragePtr
+    (
+        AveragingMethod<scalar>::New
+        (
+            IOobject
+            (
+                cloud.name() + ":weightAverage",
+                cloud.db().time().timeName(),
+                cloud.mesh()
+            ),
+            cloud.solution().dict(),
+            cloud.mesh()
+        )
+    );
+    AveragingMethod<scalar>& weightAverage = weightAveragePtr();
+
+    // averaging sums
+    forAllConstIter(typename CloudType, cloud, iter)
+    {
+        const typename CloudType::parcelType& p = iter();
+        const tetIndices tetIs(p.cell(), p.tetFace(), p.tetPt(), cloud.mesh());
+
+        const scalar m = p.nParticle()*p.mass();
+
+        volumeAverage_->add(p.position(), tetIs, p.nParticle()*p.volume());
+        rhoAverage_->add(p.position(), tetIs, m*p.rho());
+        uAverage_->add(p.position(), tetIs, m*p.U());
+        massAverage_->add(p.position(), tetIs, m);
+    }
+    volumeAverage_->average();
+    massAverage_->average();
+    rhoAverage_->average(massAverage_);
+    uAverage_->average(massAverage_);
+
+    // squared velocity deviation
+    forAllConstIter(typename CloudType, cloud, iter)
+    {
+        const typename CloudType::parcelType& p = iter();
+        const tetIndices tetIs(p.cell(), p.tetFace(), p.tetPt(), cloud.mesh());
+
+        const vector u = uAverage_->interpolate(p.position(), tetIs);
+
+        uSqrAverage_->add
+        (
+            p.position(),
+            tetIs,
+            p.nParticle()*p.mass()*magSqr(p.U() - u)
+        );
+    }
+    uSqrAverage_->average(massAverage_);
+
+    // sauter mean radius
+    radiusAverage_() = volumeAverage_();
+    weightAverage = 0;
+    forAllConstIter(typename CloudType, cloud, iter)
+    {
+        const typename CloudType::parcelType& p = iter();
+        const tetIndices tetIs(p.cell(), p.tetFace(), p.tetPt(), cloud.mesh());
+
+        weightAverage.add
+        (
+            p.position(),
+            tetIs,
+            p.nParticle()*pow(p.volume(), 2.0/3.0)
+        );
+    }
+    weightAverage.average();
+    radiusAverage_->average(weightAverage);
+
+    // collision frequency
+    weightAverage = 0;
+    forAllConstIter(typename CloudType, cloud, iter)
+    {
+        const typename CloudType::parcelType& p = iter();
+        tetIndices tetIs(p.cell(), p.tetFace(), p.tetPt(), cloud.mesh());
+
+        const scalar a = volumeAverage_->interpolate(p.position(), tetIs);
+        const scalar r = radiusAverage_->interpolate(p.position(), tetIs);
+        const vector u = uAverage_->interpolate(p.position(), tetIs);
+
+        const scalar f = 0.75*a/pow3(r)*sqr(0.5*p.d() + r)*mag(p.U() - u);
+
+        frequencyAverage_->add(p.position(), tetIs, p.nParticle()*f*f);
+
+        weightAverage.add(p.position(), tetIs, p.nParticle()*f);
+    }
+    frequencyAverage_->average(weightAverage);
+}
+
+
+template<class ParcelType>
+template<class CloudType>
+inline typename Foam::MPPICParcel<ParcelType>::template
+TrackingData<CloudType>::trackPart
+Foam::MPPICParcel<ParcelType>::TrackingData<CloudType>::part() const
+{
+    return part_;
+}
+
+
+template<class ParcelType>
+template<class CloudType>
+inline typename Foam::MPPICParcel<ParcelType>::template
+TrackingData<CloudType>::trackPart&
+Foam::MPPICParcel<ParcelType>::TrackingData<CloudType>::part()
+{
+    return part_;
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/parcels/derived/basicKinematicMPPICParcel/basicKinematicMPPICParcel.H b/src/lagrangian/intermediate/parcels/derived/basicKinematicMPPICParcel/basicKinematicMPPICParcel.H
new file mode 100644
index 0000000000000000000000000000000000000000..d72dd5366142fb4795085b2eb00192ab30351fd2
--- /dev/null
+++ b/src/lagrangian/intermediate/parcels/derived/basicKinematicMPPICParcel/basicKinematicMPPICParcel.H
@@ -0,0 +1,60 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::basicKinematicMPPICParcel
+
+Description
+    Definition of basic kinematic MPPIC parcel
+
+SourceFiles
+    basicKinematicMPPICParcel.H
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef basicKinematicMPPICParcel_H
+#define basicKinematicMPPICParcel_H
+
+#include "contiguous.H"
+#include "particle.H"
+#include "KinematicParcel.H"
+#include "MPPICParcel.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    typedef MPPICParcel<KinematicParcel<particle> > basicKinematicMPPICParcel;
+
+    template<>
+    inline bool contiguous<basicKinematicMPPICParcel>()
+    {
+        return true;
+    }
+}
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/parcels/derived/basicKinematicMPPICParcel/defineBasicKinematicMPPICParcel.C b/src/lagrangian/intermediate/parcels/derived/basicKinematicMPPICParcel/defineBasicKinematicMPPICParcel.C
new file mode 100644
index 0000000000000000000000000000000000000000..2e0050a38fe2fb7b2e89621bfe70ecf37e5a6abe
--- /dev/null
+++ b/src/lagrangian/intermediate/parcels/derived/basicKinematicMPPICParcel/defineBasicKinematicMPPICParcel.C
@@ -0,0 +1,38 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "basicKinematicMPPICParcel.H"
+#include "Cloud.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    defineTemplateTypeNameAndDebug(basicKinematicMPPICParcel, 0);
+    defineTemplateTypeNameAndDebug(Cloud<basicKinematicMPPICParcel>, 0);
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/parcels/derived/basicKinematicMPPICParcel/makeBasicKinematicMPPICParcelSubmodels.C b/src/lagrangian/intermediate/parcels/derived/basicKinematicMPPICParcel/makeBasicKinematicMPPICParcelSubmodels.C
new file mode 100644
index 0000000000000000000000000000000000000000..735c21f3efc714365ae45398c5ec3b247db00fdd
--- /dev/null
+++ b/src/lagrangian/intermediate/parcels/derived/basicKinematicMPPICParcel/makeBasicKinematicMPPICParcelSubmodels.C
@@ -0,0 +1,64 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "basicKinematicMPPICCloud.H"
+
+#include "makeParcelCloudFunctionObjects.H"
+
+// kinematic sub-models
+#include "makeParcelForces.H"
+#include "makeParcelDispersionModels.H"
+#include "makeParcelInjectionModels.H"
+#include "makeParcelPatchInteractionModels.H"
+#include "makeParcelStochasticCollisionModels.H"
+#include "makeParcelSurfaceFilmModels.H"
+
+// MPPIC sub-models
+#include "makeMPPICParcelDampingModels.H"
+#include "makeMPPICParcelIsotropyModels.H"
+#include "makeMPPICParcelPackingModels.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    makeParcelCloudFunctionObjects(basicKinematicMPPICCloud);
+
+    // kinematic sub-models
+    makeParcelForces(basicKinematicMPPICCloud);
+    makeParcelDispersionModels(basicKinematicMPPICCloud);
+    makeParcelInjectionModels(basicKinematicMPPICCloud);
+    makeParcelPatchInteractionModels(basicKinematicMPPICCloud);
+    makeParcelStochasticCollisionModels(basicKinematicMPPICCloud);
+    makeParcelSurfaceFilmModels(basicKinematicMPPICCloud);
+
+    // MPPIC sub-models
+    makeMPPICParcelDampingModels(basicKinematicMPPICCloud);
+    makeMPPICParcelIsotropyModels(basicKinematicMPPICCloud);
+    makeMPPICParcelPackingModels(basicKinematicMPPICCloud);
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/parcels/include/makeMPPICParcelDampingModels.H b/src/lagrangian/intermediate/parcels/include/makeMPPICParcelDampingModels.H
new file mode 100644
index 0000000000000000000000000000000000000000..9513a59cc3724e710006b65c92b72f8124ab3b39
--- /dev/null
+++ b/src/lagrangian/intermediate/parcels/include/makeMPPICParcelDampingModels.H
@@ -0,0 +1,51 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef makeMPPICParcelDampingModels_H
+#define makeMPPICParcelDampingModels_H
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#include "DampingModel.H"
+#include "NoDamping.H"
+#include "Relaxation.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#define makeMPPICParcelDampingModels(CloudType)                               \
+                                                                              \
+    makeDampingModel(CloudType);                                              \
+                                                                              \
+    namespace DampingModels                                                   \
+    {                                                                         \
+        makeDampingModelType(NoDamping, CloudType);                           \
+        makeDampingModelType(Relaxation, CloudType);                          \
+    }
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/parcels/include/makeMPPICParcelIsotropyModels.H b/src/lagrangian/intermediate/parcels/include/makeMPPICParcelIsotropyModels.H
new file mode 100644
index 0000000000000000000000000000000000000000..eebab863ea6d7ba5c374d6a4b48f2c85dee7ed98
--- /dev/null
+++ b/src/lagrangian/intermediate/parcels/include/makeMPPICParcelIsotropyModels.H
@@ -0,0 +1,51 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef makeMPPICParcelIsotropyModels_H
+#define makeMPPICParcelIsotropyModels_H
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#include "NoIsotropy.H"
+#include "Stochastic.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#define makeMPPICParcelIsotropyModels(CloudType)                              \
+                                                                              \
+    makeIsotropyModel(CloudType);                                             \
+                                                                              \
+    namespace IsotropyModels                                                  \
+    {                                                                         \
+        makeIsotropyModelType(NoIsotropy, CloudType);                         \
+        makeIsotropyModelType(Stochastic, CloudType);                         \
+    }
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/parcels/include/makeMPPICParcelPackingModels.H b/src/lagrangian/intermediate/parcels/include/makeMPPICParcelPackingModels.H
new file mode 100644
index 0000000000000000000000000000000000000000..2a57875b492e4e9701d056d1eb4576e959969c9f
--- /dev/null
+++ b/src/lagrangian/intermediate/parcels/include/makeMPPICParcelPackingModels.H
@@ -0,0 +1,52 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef makeMPPICParcelPackingModels_H
+#define makeMPPICParcelPackingModels_H
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#include "NoPacking.H"
+#include "Explicit.H"
+#include "Implicit.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#define makeMPPICParcelPackingModels(CloudType)                               \
+                                                                              \
+    makePackingModel(CloudType);                                              \
+                                                                              \
+    namespace PackingModels                                                   \
+    {                                                                         \
+        makePackingModelType(NoPacking, CloudType);                           \
+        makePackingModelType(Explicit, CloudType);                            \
+        makePackingModelType(Implicit, CloudType);                            \
+    }
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/parcels/include/makeParcelDispersionModels.H b/src/lagrangian/intermediate/parcels/include/makeParcelDispersionModels.H
index f1776b81ea73b292be0c13d5c23ee57845d41d19..fac015c7e8977910848356f77d7ebb71fb77e50c 100644
--- a/src/lagrangian/intermediate/parcels/include/makeParcelDispersionModels.H
+++ b/src/lagrangian/intermediate/parcels/include/makeParcelDispersionModels.H
@@ -29,25 +29,13 @@ License
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
 #include "NoDispersion.H"
-#include "GradientDispersionRAS.H"
-#include "StochasticDispersionRAS.H"
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
 #define makeParcelDispersionModels(CloudType)                                 \
                                                                               \
     makeDispersionModel(CloudType);                                           \
-                                                                              \
-    typedef CloudType::kinematicCloudType kinematicCloudType;                 \
-    defineNamedTemplateTypeNameAndDebug                                       \
-    (                                                                         \
-        DispersionRASModel<kinematicCloudType>,                               \
-        0                                                                     \
-    );                                                                        \
-                                                                              \
-    makeDispersionModelType(NoDispersion, CloudType);                         \
-    makeDispersionModelType(GradientDispersionRAS, CloudType);                \
-    makeDispersionModelType(StochasticDispersionRAS, CloudType);
+    makeDispersionModelType(NoDispersion, CloudType);
 
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
diff --git a/src/lagrangian/intermediate/parcels/include/makeParcelForces.H b/src/lagrangian/intermediate/parcels/include/makeParcelForces.H
index 9516b16a00e329472cfa399cb49a48db8934431b..47486897ba39c45fb87706eaf0ce026efb7c056f 100644
--- a/src/lagrangian/intermediate/parcels/include/makeParcelForces.H
+++ b/src/lagrangian/intermediate/parcels/include/makeParcelForces.H
@@ -30,6 +30,9 @@ License
 
 #include "SphereDragForce.H"
 #include "NonSphereDragForce.H"
+#include "WenYuDragForce.H"
+#include "ErgunWenYuDragForce.H"
+#include "PlessisMasliyahDragForce.H"
 
 #include "SaffmanMeiLiftForce.H"
 #include "TomiyamaLiftForce.H"
@@ -48,6 +51,9 @@ License
     makeParticleForceModel(CloudType);                                        \
     makeParticleForceModelType(SphereDragForce, CloudType);                   \
     makeParticleForceModelType(NonSphereDragForce, CloudType);                \
+    makeParticleForceModelType(WenYuDragForce, CloudType);                    \
+    makeParticleForceModelType(ErgunWenYuDragForce, CloudType);               \
+    makeParticleForceModelType(PlessisMasliyahDragForce, CloudType);          \
     makeParticleForceModelType(SaffmanMeiLiftForce, CloudType);               \
     makeParticleForceModelType(TomiyamaLiftForce, CloudType);                 \
     makeParticleForceModelType(GravityForce, CloudType);                      \
diff --git a/src/lagrangian/intermediate/parcels/include/makeThermoParcelForces.H b/src/lagrangian/intermediate/parcels/include/makeThermoParcelForces.H
index 29b3d6acfe0d7c2cae0b36fb9d8644d2a772366e..6045ae28276594e6d3835b3304fd40b8044689cc 100644
--- a/src/lagrangian/intermediate/parcels/include/makeThermoParcelForces.H
+++ b/src/lagrangian/intermediate/parcels/include/makeThermoParcelForces.H
@@ -34,7 +34,6 @@ License
 #include "SaffmanMeiLiftForce.H"
 #include "TomiyamaLiftForce.H"
 
-#include "BrownianMotionForce.H"
 #include "GravityForce.H"
 #include "NonInertialFrameForce.H"
 #include "ParamagneticForce.H"
@@ -51,7 +50,6 @@ License
     makeParticleForceModelType(NonSphereDragForce, CloudType);                \
     makeParticleForceModelType(SaffmanMeiLiftForce, CloudType);               \
     makeParticleForceModelType(TomiyamaLiftForce, CloudType);                 \
-    makeParticleForceModelType(BrownianMotionForce, CloudType);               \
     makeParticleForceModelType(GravityForce, CloudType);                      \
     makeParticleForceModelType(NonInertialFrameForce, CloudType);             \
     makeParticleForceModelType(ParamagneticForce, CloudType);                 \
diff --git a/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/ErgunWenYuDrag/ErgunWenYuDragForce.C b/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/ErgunWenYuDrag/ErgunWenYuDragForce.C
new file mode 100644
index 0000000000000000000000000000000000000000..ae26d5052786777d53698e5b4282e351d1051e48
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/ErgunWenYuDrag/ErgunWenYuDragForce.C
@@ -0,0 +1,128 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "ErgunWenYuDragForce.H"
+#include "volFields.H"
+
+// * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::scalar Foam::ErgunWenYuDragForce<CloudType>::CdRe
+(
+    const scalar Re
+) const
+{
+    if (Re > 1000.0)
+    {
+        return 0.44*Re;
+    }
+    else
+    {
+        return 24.0*(1.0 + 0.15*pow(Re, 0.687));
+    }
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::ErgunWenYuDragForce<CloudType>::ErgunWenYuDragForce
+(
+    CloudType& owner,
+    const fvMesh& mesh,
+    const dictionary& dict
+)
+:
+    ParticleForce<CloudType>(owner, mesh, dict, typeName, true),
+    alphac_
+    (
+        this->mesh().template lookupObject<volScalarField>
+        (
+            this->coeffs().lookup("alphac")
+        )
+    )
+{}
+
+
+template<class CloudType>
+Foam::ErgunWenYuDragForce<CloudType>::ErgunWenYuDragForce
+(
+    const ErgunWenYuDragForce<CloudType>& df
+)
+:
+    ParticleForce<CloudType>(df),
+    alphac_
+    (
+        this->mesh().template lookupObject<volScalarField>
+        (
+            this->coeffs().lookup("alphac")
+        )
+    )
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::ErgunWenYuDragForce<CloudType>::~ErgunWenYuDragForce()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::forceSuSp Foam::ErgunWenYuDragForce<CloudType>::calcCoupled
+(
+    const typename CloudType::parcelType& p,
+    const scalar dt,
+    const scalar mass,
+    const scalar Re,
+    const scalar muc
+) const
+{
+    scalar alphac(alphac_[p.cell()]);
+
+    if (alphac < 0.8)
+    {
+        return forceSuSp
+        (
+            vector::zero,
+            (mass/p.rho())
+           *(150.0*(1.0 - alphac) + 1.75*Re)*muc/(alphac*sqr(p.d()))
+        );
+    }
+    else
+    {
+        return forceSuSp
+        (
+            vector::zero,
+            (mass/p.rho())
+           *0.75*CdRe(alphac*Re)*muc*pow(alphac, -2.65)/sqr(p.d())
+        );
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/ErgunWenYuDrag/ErgunWenYuDragForce.H b/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/ErgunWenYuDrag/ErgunWenYuDragForce.H
new file mode 100644
index 0000000000000000000000000000000000000000..1d10ea6b42fb26ce0a71824cd29320c8d559bacf
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/ErgunWenYuDrag/ErgunWenYuDragForce.H
@@ -0,0 +1,127 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::ErgunWenYuDragForce
+
+Description
+    Ergun-Wen-Yu drag model for solid spheres.
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef ErgunWenYuDragForce_H
+#define ErgunWenYuDragForce_H
+
+#include "ParticleForce.H"
+#include "volFieldsFwd.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+/*---------------------------------------------------------------------------*\
+                       Class ErgunWenYuDragForce Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class CloudType>
+class ErgunWenYuDragForce
+:
+    public ParticleForce<CloudType>
+{
+    // Private Data
+
+        //- Reference to the carrier volume fraction field
+        const volScalarField& alphac_;
+
+
+    // Private Member Functions
+
+        //- Drag coefficient multiplied by Reynolds number
+        scalar CdRe(const scalar Re) const;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("ErgunWenYuDrag");
+
+
+    // Constructors
+
+        //- Construct from mesh
+        ErgunWenYuDragForce
+        (
+            CloudType& owner,
+            const fvMesh& mesh,
+            const dictionary& dict
+        );
+
+        //- Construct copy
+        ErgunWenYuDragForce(const ErgunWenYuDragForce<CloudType>& df);
+
+        //- Construct and return a clone
+        virtual autoPtr<ParticleForce<CloudType> > clone() const
+        {
+            return autoPtr<ParticleForce<CloudType> >
+            (
+                new ErgunWenYuDragForce<CloudType>(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~ErgunWenYuDragForce();
+
+
+    // Member Functions
+
+        // Evaluation
+
+            //- Calculate the coupled force
+            virtual forceSuSp calcCoupled
+            (
+                const typename CloudType::parcelType& p,
+                const scalar dt,
+                const scalar mass,
+                const scalar Re,
+                const scalar muc
+            ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "ErgunWenYuDragForce.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/PlessisMasliyahDrag/PlessisMasliyahDragForce.C b/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/PlessisMasliyahDrag/PlessisMasliyahDragForce.C
new file mode 100644
index 0000000000000000000000000000000000000000..1b7dee57ee591a7ebebe893dbe9fc6da52903a9f
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/PlessisMasliyahDrag/PlessisMasliyahDragForce.C
@@ -0,0 +1,131 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "PlessisMasliyahDragForce.H"
+#include "volFields.H"
+
+// * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::scalar Foam::PlessisMasliyahDragForce<CloudType>::CdRe
+(
+    const scalar Re
+) const
+{
+    if (Re > 1000.0)
+    {
+        return 0.44*Re;
+    }
+    else
+    {
+        return 24.0*(1.0 + 0.15*pow(Re, 0.687));
+    }
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::PlessisMasliyahDragForce<CloudType>::PlessisMasliyahDragForce
+(
+    CloudType& owner,
+    const fvMesh& mesh,
+    const dictionary& dict
+)
+:
+    ParticleForce<CloudType>(owner, mesh, dict, typeName, true),
+    alphac_
+    (
+        this->mesh().template lookupObject<volScalarField>
+        (
+            this->coeffs().lookup("alphac")
+        )
+    )
+{}
+
+
+template<class CloudType>
+Foam::PlessisMasliyahDragForce<CloudType>::PlessisMasliyahDragForce
+(
+    const PlessisMasliyahDragForce<CloudType>& df
+)
+:
+    ParticleForce<CloudType>(df),
+    alphac_
+    (
+        this->mesh().template lookupObject<volScalarField>
+        (
+            this->coeffs().lookup("alphac")
+        )
+    )
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::PlessisMasliyahDragForce<CloudType>::~PlessisMasliyahDragForce()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::forceSuSp Foam::PlessisMasliyahDragForce<CloudType>::calcCoupled
+(
+    const typename CloudType::parcelType& p,
+    const scalar dt,
+    const scalar mass,
+    const scalar Re,
+    const scalar muc
+) const
+{
+    scalar alphac(alphac_[p.cell()]);
+
+    scalar cbrtAlphap(pow(1.0 - alphac, 1.0/3.0));
+
+    scalar A =
+        26.8*pow3(alphac)
+       /(
+            sqr(cbrtAlphap)
+           *(1.0 - cbrtAlphap)
+           *sqr(1.0 - sqr(cbrtAlphap))
+          + SMALL
+        );
+
+    scalar B =
+        sqr(alphac)
+       /sqr(1.0 - sqr(cbrtAlphap));
+
+    return forceSuSp
+    (
+        vector::zero,
+        (mass/p.rho())
+       *(A*(1.0 - alphac) + B*Re)*muc/(alphac*sqr(p.d()))
+    );
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/PlessisMasliyahDrag/PlessisMasliyahDragForce.H b/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/PlessisMasliyahDrag/PlessisMasliyahDragForce.H
new file mode 100644
index 0000000000000000000000000000000000000000..5bd9be8e453bc07e18aa691a0ec8e6658315b3ca
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/PlessisMasliyahDrag/PlessisMasliyahDragForce.H
@@ -0,0 +1,127 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::PlessisMasliyahDragForce
+
+Description
+    PlessisMasliyahDragForce drag model for solid spheres.
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef PlessisMasliyahDragForce_H
+#define PlessisMasliyahDragForce_H
+
+#include "ParticleForce.H"
+#include "volFieldsFwd.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+/*---------------------------------------------------------------------------*\
+                       Class PlessisMasliyahDragForce Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class CloudType>
+class PlessisMasliyahDragForce
+:
+    public ParticleForce<CloudType>
+{
+    // Private Data
+
+        //- Reference to the carrier volume fraction field
+        const volScalarField& alphac_;
+
+
+    // Private Member Functions
+
+        //- Drag coefficient multiplied by Reynolds number
+        scalar CdRe(const scalar Re) const;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("PlessisMasliyahDrag");
+
+
+    // Constructors
+
+        //- Construct from mesh
+        PlessisMasliyahDragForce
+        (
+            CloudType& owner,
+            const fvMesh& mesh,
+            const dictionary& dict
+        );
+
+        //- Construct copy
+        PlessisMasliyahDragForce(const PlessisMasliyahDragForce<CloudType>& df);
+
+        //- Construct and return a clone
+        virtual autoPtr<ParticleForce<CloudType> > clone() const
+        {
+            return autoPtr<ParticleForce<CloudType> >
+            (
+                new PlessisMasliyahDragForce<CloudType>(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~PlessisMasliyahDragForce();
+
+
+    // Member Functions
+
+        // Evaluation
+
+            //- Calculate the coupled force
+            virtual forceSuSp calcCoupled
+            (
+                const typename CloudType::parcelType& p,
+                const scalar dt,
+                const scalar mass,
+                const scalar Re,
+                const scalar muc
+            ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "PlessisMasliyahDragForce.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/WenYuDrag/WenYuDragForce.C b/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/WenYuDrag/WenYuDragForce.C
new file mode 100644
index 0000000000000000000000000000000000000000..415bd06b2dc0d1ff960b41fe7a5a97c8307cbc54
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/WenYuDrag/WenYuDragForce.C
@@ -0,0 +1,113 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "WenYuDragForce.H"
+#include "volFields.H"
+
+// * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::scalar Foam::WenYuDragForce<CloudType>::CdRe(const scalar Re) const
+{
+    if (Re > 1000.0)
+    {
+        return 0.44*Re;
+    }
+    else
+    {
+        return 24.0*(1.0 + 0.15*pow(Re, 0.687));
+    }
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::WenYuDragForce<CloudType>::WenYuDragForce
+(
+    CloudType& owner,
+    const fvMesh& mesh,
+    const dictionary& dict
+)
+:
+    ParticleForce<CloudType>(owner, mesh, dict, typeName, true),
+    alphac_
+    (
+        this->mesh().template lookupObject<volScalarField>
+        (
+            this->coeffs().lookup("alphac")
+        )
+    )
+{}
+
+
+template<class CloudType>
+Foam::WenYuDragForce<CloudType>::WenYuDragForce
+(
+    const WenYuDragForce<CloudType>& df
+)
+:
+    ParticleForce<CloudType>(df),
+    alphac_
+    (
+        this->mesh().template lookupObject<volScalarField>
+        (
+            this->coeffs().lookup("alphac")
+        )
+    )
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::WenYuDragForce<CloudType>::~WenYuDragForce()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::forceSuSp Foam::WenYuDragForce<CloudType>::calcCoupled
+(
+    const typename CloudType::parcelType& p,
+    const scalar dt,
+    const scalar mass,
+    const scalar Re,
+    const scalar muc
+) const
+{
+    scalar alphac(alphac_[p.cell()]);
+
+    return forceSuSp
+    (
+        vector::zero,
+        (mass/p.rho())
+       *0.75*CdRe(alphac*Re)*muc*pow(alphac, -2.65)/sqr(p.d())
+    );
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/WenYuDrag/WenYuDragForce.H b/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/WenYuDrag/WenYuDragForce.H
new file mode 100644
index 0000000000000000000000000000000000000000..46a6ff5e19f7b050d6cfed43685d61a722a3aeec
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/Kinematic/ParticleForces/Drag/WenYuDrag/WenYuDragForce.H
@@ -0,0 +1,127 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::WenYuDragForce
+
+Description
+    Wen-Yu drag model for solid spheres.
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef WenYuDragForce_H
+#define WenYuDragForce_H
+
+#include "ParticleForce.H"
+#include "volFieldsFwd.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+/*---------------------------------------------------------------------------*\
+                       Class WenYuDragForce Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class CloudType>
+class WenYuDragForce
+:
+    public ParticleForce<CloudType>
+{
+    // Private Data
+
+        //- Reference to the carrier volume fraction field
+        const volScalarField& alphac_;
+
+
+    // Private Member Functions
+
+        //- Drag coefficient multiplied by Reynolds number
+        scalar CdRe(const scalar Re) const;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("WenYuDrag");
+
+
+    // Constructors
+
+        //- Construct from mesh
+        WenYuDragForce
+        (
+            CloudType& owner,
+            const fvMesh& mesh,
+            const dictionary& dict
+        );
+
+        //- Construct copy
+        WenYuDragForce(const WenYuDragForce<CloudType>& df);
+
+        //- Construct and return a clone
+        virtual autoPtr<ParticleForce<CloudType> > clone() const
+        {
+            return autoPtr<ParticleForce<CloudType> >
+            (
+                new WenYuDragForce<CloudType>(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~WenYuDragForce();
+
+
+    // Member Functions
+
+        // Evaluation
+
+            //- Calculate the coupled force
+            virtual forceSuSp calcCoupled
+            (
+                const typename CloudType::parcelType& p,
+                const scalar dt,
+                const scalar mass,
+                const scalar Re,
+                const scalar muc
+            ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "WenYuDragForce.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/AveragingMethod/AveragingMethod.C b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/AveragingMethod/AveragingMethod.C
new file mode 100644
index 0000000000000000000000000000000000000000..21cb38d2ed60c753f3c1fa01d285484d42a88855
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/AveragingMethod/AveragingMethod.C
@@ -0,0 +1,255 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "AveragingMethod.H"
+#include "runTimeSelectionTables.H"
+#include "pointMesh.H"
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class Type>
+Foam::AveragingMethod<Type>::AveragingMethod
+(
+    const IOobject& io,
+    const dictionary& dict,
+    const fvMesh& mesh,
+    const labelList& size
+)
+:
+    regIOobject(io),
+    FieldField<Field, Type>(),
+    dict_(dict),
+    mesh_(mesh)
+{
+    forAll(size, i)
+    {
+        FieldField<Field, Type>::append
+        (
+            new Field<Type>(size[i], pTraits<Type>::zero)
+        );
+    }
+}
+
+
+template<class Type>
+Foam::AveragingMethod<Type>::AveragingMethod
+(
+    const AveragingMethod<Type>& am
+)
+:
+    regIOobject(am),
+    FieldField<Field, Type>(am),
+    dict_(am.dict_),
+    mesh_(am.mesh_)
+{}
+
+
+// * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * * //
+
+template<class Type>
+Foam::autoPtr<Foam::AveragingMethod<Type> >
+Foam::AveragingMethod<Type>::New
+(
+    const IOobject& io,
+    const dictionary& dict,
+    const fvMesh& mesh
+)
+{
+    word averageType(dict.lookup(typeName));
+
+    //Info<< "Selecting averaging method "
+    //    << averageType << endl;
+
+    typename dictionaryConstructorTable::iterator cstrIter =
+        dictionaryConstructorTablePtr_->find(averageType);
+
+    if (cstrIter == dictionaryConstructorTablePtr_->end())
+    {
+        FatalErrorIn
+        (
+            "Foam::AveragingMethod<Type>::New"
+            "("
+                "const dictionary&"
+                "const fvMesh&"
+            ")"
+        )   << "Unknown averaging method " << averageType
+            << ", constructor not in hash table" << nl << nl
+            << "    Valid averaging methods are:" << nl
+            << dictionaryConstructorTablePtr_->sortedToc()
+            << abort(FatalError);
+    }
+
+    return autoPtr<AveragingMethod<Type> >(cstrIter()(io, dict, mesh));
+}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class Type>
+Foam::AveragingMethod<Type>::~AveragingMethod()
+{}
+
+
+// * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
+
+template<class Type>
+void Foam::AveragingMethod<Type>::updateGrad()
+{
+    // do nothing
+}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class Type>
+void Foam::AveragingMethod<Type>::average()
+{
+    updateGrad();
+}
+
+
+template<class Type>
+void Foam::AveragingMethod<Type>::average
+(
+    const AveragingMethod<scalar>& weight
+)
+{
+    updateGrad();
+
+    *this /= max(weight, SMALL);
+}
+
+
+template<class Type>
+bool Foam::AveragingMethod<Type>::writeData(Ostream& os) const
+{
+    return os.good();
+}
+
+
+template<class Type>
+bool Foam::AveragingMethod<Type>::write() const
+{
+    const pointMesh pointMesh_(mesh_);
+
+    // point volumes
+    Field<scalar> pointVolume(mesh_.nPoints(), 0);
+
+    // output fields
+    GeometricField<Type, fvPatchField, volMesh> cellValue
+    (
+        IOobject
+        (
+            this->name() + ":cellValue",
+            this->time().timeName(),
+            mesh_
+        ),
+        mesh_,
+        dimensioned<Type>("zero", dimless, pTraits<Type>::zero)
+    );
+    GeometricField<TypeGrad, fvPatchField, volMesh> cellGrad
+    (
+        IOobject
+        (
+            this->name() + ":cellGrad",
+            this->time().timeName(),
+            mesh_
+        ),
+        mesh_,
+        dimensioned<TypeGrad>("zero", dimless, pTraits<TypeGrad>::zero)
+    );
+    GeometricField<Type, pointPatchField, pointMesh> pointValue
+    (
+        IOobject
+        (
+            this->name() + ":pointValue",
+            this->time().timeName(),
+            mesh_
+        ),
+        pointMesh_,
+        dimensioned<Type>("zero", dimless, pTraits<Type>::zero)
+    );
+    GeometricField<TypeGrad, pointPatchField, pointMesh> pointGrad
+    (
+        IOobject
+        (
+            this->name() + ":pointGrad",
+            this->time().timeName(),
+            mesh_
+        ),
+        pointMesh_,
+        dimensioned<TypeGrad>("zero", dimless, pTraits<TypeGrad>::zero)
+    );
+
+    // tet-volume weighted sums
+    forAll(mesh_.C(), cellI)
+    {
+        const List<tetIndices> cellTets =
+            polyMeshTetDecomposition::cellTetIndices(mesh_, cellI);
+
+        forAll(cellTets, tetI)
+        {
+            const tetIndices& tetIs = cellTets[tetI];
+            const scalar v = tetIs.tet(mesh_).mag();
+
+            cellValue[cellI] += v*interpolate(mesh_.C()[cellI], tetIs);
+            cellGrad[cellI] += v*interpolateGrad(mesh_.C()[cellI], tetIs);
+
+            const face& f = mesh_.faces()[tetIs.face()];
+            labelList vertices(3);
+            vertices[0] = f[tetIs.faceBasePt()];
+            vertices[1] = f[tetIs.facePtA()];
+            vertices[2] = f[tetIs.facePtB()];
+
+            forAll(vertices, vertexI)
+            {
+                const label pointI = vertices[vertexI];
+
+                pointVolume[pointI] += v;
+                pointValue[pointI] +=
+                    v*interpolate(mesh_.points()[pointI], tetIs);
+                pointGrad[pointI] +=
+                    v*interpolateGrad(mesh_.points()[pointI], tetIs);
+            }
+        }
+    }
+
+    // average
+    cellValue.internalField() /= mesh_.V();
+    cellGrad.internalField() /= mesh_.V();
+    pointValue.internalField() /= pointVolume;
+    pointGrad.internalField() /= pointVolume;
+
+    // write
+    if(!cellValue.write()) return false;
+    if(!cellGrad.write()) return false;
+    if(!pointValue.write()) return false;
+    if(!pointGrad.write()) return false;
+
+    return true;
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/AveragingMethod/AveragingMethod.H b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/AveragingMethod/AveragingMethod.H
new file mode 100644
index 0000000000000000000000000000000000000000..dddcea6f1a34ff8a8762fce67009d77be89d2ee6
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/AveragingMethod/AveragingMethod.H
@@ -0,0 +1,207 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::AveragingMethod
+
+Description
+    Base class for lagrangian averaging methods.
+
+SourceFiles
+    AveragingMethod.C
+    AveragingMethodI.H
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef AveragingMethod_H
+#define AveragingMethod_H
+
+#include "IOdictionary.H"
+#include "autoPtr.H"
+#include "runTimeSelectionTables.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+/*---------------------------------------------------------------------------*\
+                        Class AveragingMethod Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class Type>
+class AveragingMethod
+:
+    public regIOobject,
+    public FieldField<Field, Type>
+{
+protected:
+
+    //- Protected typedefs
+
+        //- Gradient type
+        typedef typename outerProduct<vector, Type>::type TypeGrad;
+
+
+    //- Protected data
+
+        //- Dictionary
+        const dictionary& dict_;
+
+        //- The mesh on which the averaging is to be done
+        const fvMesh& mesh_;
+
+
+    //- Protected member functions
+
+        //- Update the gradient calculation
+        virtual void updateGrad();
+
+
+public:
+
+    //- Runtime type information
+    TypeName("averagingMethod");
+
+    //- Declare runtime constructor selection table
+    declareRunTimeSelectionTable
+    (
+        autoPtr,
+        AveragingMethod,
+        dictionary,
+        (
+            const IOobject& io,
+            const dictionary& dict,
+            const fvMesh& mesh
+        ),
+        (io, dict, mesh)
+    );
+
+
+    //- Constructors
+
+        //- Construct from components
+        AveragingMethod
+        (
+            const IOobject& io,
+            const dictionary& dict,
+            const fvMesh& mesh,
+            const labelList& size
+        );
+
+        //- Construct a copy
+        AveragingMethod(const AveragingMethod<Type>& am);
+
+        //- Construct and return a clone
+        virtual autoPtr<AveragingMethod<Type> > clone() const = 0;
+
+
+    //- Selector
+    static autoPtr<AveragingMethod<Type> > New
+    (
+        const IOobject& io,
+        const dictionary& dict,
+        const fvMesh& mesh
+    );
+
+
+    //- Destructor
+    virtual ~AveragingMethod();
+
+
+    //- Member Functions
+
+        //- Add point value to interpolation
+        virtual void add
+        (
+            const point position,
+            const tetIndices& tetIs,
+            const Type& value
+        ) = 0;
+
+        //- Interpolate
+        virtual Type interpolate
+        (
+            const point position,
+            const tetIndices& tetIs
+        ) const = 0;
+
+        //- Interpolate gradient
+        virtual TypeGrad interpolateGrad
+        (
+            const point position,
+            const tetIndices& tetIs
+        ) const = 0;
+
+        //- Calculate the average
+        virtual void average();
+        virtual void average(const AveragingMethod<scalar>& weight);
+
+        //- Dummy write
+        virtual bool writeData(Ostream&) const;
+
+        //- Write using setting from DB
+        virtual bool write() const;
+
+        //- Return an internal field of the average
+        virtual tmp<Field<Type> > internalField() const = 0;
+
+        //- Assign to another average
+        inline void operator=(const AveragingMethod<Type>& x);
+
+        //- Assign to value
+        inline void operator=(const Type& x);
+
+        //- Assign to tmp
+        inline void operator=(tmp<FieldField<Field, Type> > x);
+
+        //- Add-equal tmp
+        inline void operator+=(tmp<FieldField<Field, Type> > x);
+
+        //- Multiply-equal tmp
+        inline void operator*=(tmp<FieldField<Field, Type> > x);
+
+        //- Divide-equal tmp
+        inline void operator/=(tmp<FieldField<Field, scalar> > x);
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#include "AveragingMethodI.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "AveragingMethod.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/AveragingMethod/AveragingMethodI.H b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/AveragingMethod/AveragingMethodI.H
new file mode 100644
index 0000000000000000000000000000000000000000..87bc4ac904aee5fcf0ad6691864e8aaf2f764869
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/AveragingMethod/AveragingMethodI.H
@@ -0,0 +1,94 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class Type>
+inline void Foam::AveragingMethod<Type>::operator=
+(
+    const AveragingMethod<Type>& x
+)
+{
+    FieldField<Field, Type>::operator=(x);
+    updateGrad();
+}
+
+
+template<class Type>
+inline void Foam::AveragingMethod<Type>::operator=
+(
+    const Type& x
+)
+{
+    FieldField<Field, Type>::operator=(x);
+    updateGrad();
+}
+
+
+template<class Type>
+inline void Foam::AveragingMethod<Type>::operator=
+(
+    tmp<FieldField<Field, Type> > x
+)
+{
+    FieldField<Field, Type>::operator=(x());
+    updateGrad();
+}
+
+
+template<class Type>
+inline void Foam::AveragingMethod<Type>::operator+=
+(
+    tmp<FieldField<Field, Type> > x
+)
+{
+    FieldField<Field, Type>::operator+=(x());
+    updateGrad();
+}
+
+
+template<class Type>
+inline void Foam::AveragingMethod<Type>::operator*=
+(
+    tmp<FieldField<Field, Type> > x
+)
+{
+    FieldField<Field, Type>::operator*=(x());
+    updateGrad();
+}
+
+
+template<class Type>
+inline void Foam::AveragingMethod<Type>::operator/=
+(
+    tmp<FieldField<Field, scalar> > x
+)
+{
+    FieldField<Field, Type>::operator/=(x());
+    updateGrad();
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Basic/Basic.C b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Basic/Basic.C
new file mode 100644
index 0000000000000000000000000000000000000000..576153d96d9c2d8b5adbba8377ef0c3e4150119d
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Basic/Basic.C
@@ -0,0 +1,133 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "Basic.H"
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class Type>
+Foam::AveragingMethods::Basic<Type>::Basic
+(
+    const IOobject& io,
+    const dictionary& dict,
+    const fvMesh& mesh
+)
+:
+    AveragingMethod<Type>(io, dict, mesh, labelList(1, mesh.nCells())),
+    data_(FieldField<Field, Type>::operator[](0)),
+    dataGrad_(mesh.nCells())
+{}
+
+
+template<class Type>
+Foam::AveragingMethods::Basic<Type>::Basic
+(
+    const Basic<Type>& am
+)
+:
+    AveragingMethod<Type>(am),
+    data_(FieldField<Field, Type>::operator[](0)),
+    dataGrad_(am.dataGrad_)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class Type>
+Foam::AveragingMethods::Basic<Type>::~Basic()
+{}
+
+
+// * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
+
+template<class Type>
+void Foam::AveragingMethods::Basic<Type>::updateGrad()
+{
+    GeometricField<Type, fvPatchField, volMesh> tempData
+    (
+        IOobject
+        (
+            "BasicAverage::Data",
+            this->mesh_,
+            IOobject::NO_READ,
+            IOobject::NO_WRITE,
+            false
+        ),
+        this->mesh_,
+        dimensioned<Type>("zero", dimless, pTraits<Type>::zero),
+        zeroGradientFvPatchField<Type>::typeName
+    );
+    tempData.internalField() = data_;
+    tempData.correctBoundaryConditions();
+    dataGrad_ = fvc::grad(tempData)->internalField();
+}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class Type>
+void Foam::AveragingMethods::Basic<Type>::add
+(
+    const point position,
+    const tetIndices& tetIs,
+    const Type& value
+)
+{
+    data_[tetIs.cell()] += value/this->mesh_.V()[tetIs.cell()];
+}
+
+
+template<class Type>
+Type Foam::AveragingMethods::Basic<Type>::interpolate
+(
+    const point position,
+    const tetIndices& tetIs
+) const
+{
+    return data_[tetIs.cell()];
+}
+
+
+template<class Type>
+typename Foam::AveragingMethods::Basic<Type>::TypeGrad
+Foam::AveragingMethods::Basic<Type>::interpolateGrad
+(
+    const point position,
+    const tetIndices& tetIs
+) const
+{
+    return dataGrad_[tetIs.cell()];
+}
+
+
+template<class Type>
+Foam::tmp<Foam::Field<Type> >
+Foam::AveragingMethods::Basic<Type>::internalField() const
+{
+    return tmp<Field<Type> >(data_);
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Basic/Basic.H b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Basic/Basic.H
new file mode 100644
index 0000000000000000000000000000000000000000..4123b47ed9380f212d3391e94fed8abfcc85d26a
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Basic/Basic.H
@@ -0,0 +1,170 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::AveragingMethods::Basic
+
+Description
+    Basic lagrangian averaging procedure.
+
+    This is a cell-volume based average. Point values are summed over the
+    computational cells and the result is divided by the cell volume.
+    
+    Interpolation is done assuming a constant value over each cells. Cell
+    gradients are calculated by the default fvc::grad scheme, and are also
+    assumed constant when interpolated.
+
+SourceFiles
+    Basic.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef Basic_H
+#define Basic_H
+
+#include "AveragingMethod.H"
+#include "pointMesh.H"
+#include "tetIndices.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace AveragingMethods
+{
+
+/*---------------------------------------------------------------------------*\
+                        Class Basic Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class Type>
+class Basic
+:
+    public AveragingMethod<Type>
+{
+public:
+
+    //- Public typedefs
+
+        //- Gradient type
+        typedef typename AveragingMethod<Type>::TypeGrad TypeGrad;
+
+
+private:
+
+    //- Private data
+
+        //- Cell average field
+        Field<Type>& data_;
+
+        //- Gradient field
+        Field<TypeGrad> dataGrad_;
+
+
+    //- Private member functions
+
+        //- Re-calculate gradient
+        virtual void updateGrad();
+
+
+public:
+
+    //- Runtime type information
+    TypeName("basic");
+
+
+    //- Constructors
+
+        //- Construct from components
+        Basic
+        (
+            const IOobject& io,
+            const dictionary& dict,
+            const fvMesh &mesh
+        );
+
+        //- Construct a copy
+        Basic(const Basic<Type>& am);
+
+        //- Construct and return a clone
+        virtual autoPtr<AveragingMethod<Type> > clone() const
+        {
+            return autoPtr<AveragingMethod<Type> >
+            (
+                new Basic<Type>(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~Basic();
+
+
+    //- Member Functions
+
+        //- Add point value to interpolation
+        void add
+        (
+            const point position,
+            const tetIndices& tetIs,
+            const Type& value
+        );
+
+        //- Interpolate
+        Type interpolate
+        (
+            const point position,
+            const tetIndices& tetIs
+        ) const;
+
+        //- Interpolate gradient
+        TypeGrad interpolateGrad
+        (
+            const point position,
+            const tetIndices& tetIs
+        ) const;
+
+        //- Return an internal field of the average
+        tmp<Field<Type> > internalField() const;
+
+        //- Return an internal field of the gradient
+        tmp<Field<TypeGrad> > internalFieldGrad() const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace AveragingMethods
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "Basic.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Dual/Dual.C b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Dual/Dual.C
new file mode 100644
index 0000000000000000000000000000000000000000..51d9b5b6e5334a4aadfe95ccbbac2645a2d1142c
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Dual/Dual.C
@@ -0,0 +1,253 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "Dual.H"
+#include "coupledPointPatchField.H"
+
+// * * * * * * * * * * * * * Static Member Functions * * * * * * * * * * * * //
+
+template<class Type>
+Foam::autoPtr<labelList> Foam::AveragingMethods::Dual<Type>::size
+(
+    const fvMesh& mesh
+)
+{
+    autoPtr<labelList> s(new labelList(2));
+    s()[0] = mesh.nCells();
+    s()[1] = mesh.nPoints();
+    return s;
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class Type>
+Foam::AveragingMethods::Dual<Type>::Dual
+(
+    const IOobject& io,
+    const dictionary& dict,
+    const fvMesh& mesh
+)
+:
+    AveragingMethod<Type>(io, dict, mesh, size(mesh)),
+    volumeCell_(mesh.V()),
+    volumeDual_(mesh.nPoints(), 0.0),
+    dataCell_(FieldField<Field, Type>::operator[](0)),
+    dataDual_(FieldField<Field, Type>::operator[](1)),
+    tetVertices_(3),
+    tetCoordinates_(4)
+{
+    forAll(this->mesh_.C(), cellI)
+    {
+        List<tetIndices> cellTets =
+            polyMeshTetDecomposition::cellTetIndices(this->mesh_, cellI);
+        forAll(cellTets, tetI)
+        {
+            const tetIndices& tetIs = cellTets[tetI];
+            const face& f = this->mesh_.faces()[tetIs.face()];
+            const scalar v = tetIs.tet(this->mesh_).mag();
+            volumeDual_[f[tetIs.faceBasePt()]] += v;
+            volumeDual_[f[tetIs.facePtA()]] += v;
+            volumeDual_[f[tetIs.facePtB()]] += v;
+        }
+    }
+
+    mesh.globalData().syncPointData
+    (
+        volumeDual_,
+        plusEqOp<scalar>(),
+        mapDistribute::transform()
+    );
+}
+
+
+template<class Type>
+Foam::AveragingMethods::Dual<Type>::Dual
+(
+    const Dual<Type>& am
+)
+:
+    AveragingMethod<Type>(am),
+    volumeCell_(am.volumeCell_),
+    volumeDual_(am.volumeDual_),
+    dataCell_(FieldField<Field, Type>::operator[](0)),
+    dataDual_(FieldField<Field, Type>::operator[](1)),
+    tetVertices_(am.tetVertices_),
+    tetCoordinates_(am.tetCoordinates_)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class Type>
+Foam::AveragingMethods::Dual<Type>::~Dual()
+{}
+
+
+// * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
+
+template<class Type>
+void Foam::AveragingMethods::Dual<Type>::tetGeometry
+(
+    const point position,
+    const tetIndices& tetIs
+) const
+{
+    const face& f = this->mesh_.faces()[tetIs.face()];
+
+    tetVertices_[0] = f[tetIs.faceBasePt()];
+    tetVertices_[1] = f[tetIs.facePtA()];
+    tetVertices_[2] = f[tetIs.facePtB()];
+
+    tetIs.tet(this->mesh_).barycentric(position, tetCoordinates_);
+
+    tetCoordinates_ = max(tetCoordinates_, 0.0);
+}
+
+
+template<class Type>
+void Foam::AveragingMethods::Dual<Type>::syncDualData()
+{
+    this->mesh_.globalData().syncPointData
+    (
+        dataDual_,
+        plusEqOp<Type>(),
+        mapDistribute::transform()
+    );
+}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class Type>
+void Foam::AveragingMethods::Dual<Type>::add
+(
+    const point position,
+    const tetIndices& tetIs,
+    const Type& value
+)
+{
+    tetGeometry(position, tetIs);
+
+    dataCell_[tetIs.cell()] +=
+        tetCoordinates_[0]*value
+      / (0.25*volumeCell_[tetIs.cell()]);
+
+    for(label i = 0; i < 3; i ++)
+    {
+        dataDual_[tetVertices_[i]] +=
+            tetCoordinates_[i+1]*value
+          / (0.25*volumeDual_[tetVertices_[i]]);
+    }
+}
+
+
+template<class Type>
+Type Foam::AveragingMethods::Dual<Type>::interpolate
+(
+    const point position,
+    const tetIndices& tetIs
+) const
+{
+    tetGeometry(position, tetIs);
+
+    return
+        tetCoordinates_[0]*dataCell_[tetIs.cell()]
+      + tetCoordinates_[1]*dataDual_[tetVertices_[0]]
+      + tetCoordinates_[2]*dataDual_[tetVertices_[1]]
+      + tetCoordinates_[3]*dataDual_[tetVertices_[2]];
+}
+
+
+template<class Type>
+typename Foam::AveragingMethods::Dual<Type>::TypeGrad
+Foam::AveragingMethods::Dual<Type>::interpolateGrad
+(
+    const point position,
+    const tetIndices& tetIs
+) const
+{
+    tetGeometry(position, tetIs);
+
+    const label cellI(tetIs.cell());
+
+    const tensor T
+    (
+        inv
+        (
+            tensor
+            (
+                this->mesh_.points()[tetVertices_[0]] - this->mesh_.C()[cellI],
+                this->mesh_.points()[tetVertices_[1]] - this->mesh_.C()[cellI],
+                this->mesh_.points()[tetVertices_[2]] - this->mesh_.C()[cellI]
+            )
+        )
+    );
+
+    const vector t( - T.T().x() - T.T().y() - T.T().z());
+
+    const TypeGrad S
+    (
+        dataDual_[tetVertices_[0]],
+        dataDual_[tetVertices_[1]],
+        dataDual_[tetVertices_[2]]
+    );
+
+    const Type s(dataCell_[cellI]);
+
+    return (T & S) + (t*s);
+}
+
+
+template<class Type>
+void Foam::AveragingMethods::Dual<Type>::average()
+{
+    syncDualData();
+
+    AveragingMethod<Type>::average();
+}
+
+
+template<class Type>
+void Foam::AveragingMethods::Dual<Type>::average
+(
+    const AveragingMethod<scalar>& weight
+)
+{
+    syncDualData();
+
+    AveragingMethod<Type>::average(weight);
+}
+
+
+template<class Type>
+Foam::tmp<Foam::Field<Type> >
+Foam::AveragingMethods::Dual<Type>::internalField() const
+{
+    return tmp<Field<Type> >(dataCell_);
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Dual/Dual.H b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Dual/Dual.H
new file mode 100644
index 0000000000000000000000000000000000000000..537c1270b96850fb112618bcd90c68e64517f3ac
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Dual/Dual.H
@@ -0,0 +1,203 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::AveragingMethods::Dual
+
+Description
+    Dual-mesh lagrangian averaging procedure.
+
+    Point values are summed using the tetrahedral decomposition of the
+    computational cells. Summation is done in the cells, and also in the
+    terahedrons surrounding each point. The latter forms a type of dual mesh.
+    The interpolation is weighted by proximity to the cell centre or point, as
+    calculated by the barycentric coordinate within the tethrahedron.
+    
+    Values are interpolated linearly across the tethrahedron. Gradients are
+    calculated directly from the point values using a first order finite
+    element basis. The computed gradient is assumed constant over the
+    tethrahedron.
+
+SourceFiles
+    Dual.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef Dual_H
+#define Dual_H
+
+#include "AveragingMethod.H"
+#include "pointMesh.H"
+#include "tetIndices.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace AveragingMethods
+{
+
+/*---------------------------------------------------------------------------*\
+                        Class Dual Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class Type>
+class Dual
+:
+    public AveragingMethod<Type>
+{
+public:
+
+    //- Public typedefs
+
+        //- Gradient type
+        typedef typename AveragingMethod<Type>::TypeGrad TypeGrad;
+
+
+private:
+
+    //- Private data
+
+        //- Volume of the cell-centered regions
+        const Field<scalar>& volumeCell_;
+
+        //- Volume of the point-centered regions
+        Field<scalar> volumeDual_;
+
+        //- Data on the cells
+        Field<Type>& dataCell_;
+
+        //- Data on the points
+        Field<Type>& dataDual_;
+
+        //- Tet vertex labels
+        mutable List<label> tetVertices_;
+
+        //- Tet barycentric coordinates
+        mutable List<scalar> tetCoordinates_;
+
+
+    //- Private static member functions
+    
+        //- Return the size of the FieldField parts
+        static autoPtr<labelList> size(const fvMesh &mesh);
+
+
+    //- Private member functions
+
+        //- Calculate indices and barycentric coordinates within a tetrahedron
+        void tetGeometry
+        (
+            const point position,
+            const tetIndices& tetIs
+        ) const;
+
+        //- Sync point data over processor boundaries
+        void syncDualData();
+
+
+public:
+
+    //- Runtime type information
+    TypeName("dual");
+
+
+    //- Constructors
+
+        //- Construct from components
+        Dual
+        (
+            const IOobject& io,
+            const dictionary& dict,
+            const fvMesh &mesh
+        );
+
+        //- Construct a copy
+        Dual(const Dual<Type>& am);
+
+        //- Construct and return a clone
+        virtual autoPtr<AveragingMethod<Type> > clone() const
+        {
+            return autoPtr<AveragingMethod<Type> >
+            (
+                new Dual<Type>(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~Dual();
+
+
+    //- Member Functions
+
+        //- Add point value to interpolation
+        void add
+        (
+            const point position,
+            const tetIndices& tetIs,
+            const Type& value
+        );
+
+        //- Interpolate
+        Type interpolate
+        (
+            const point position,
+            const tetIndices& tetIs
+        ) const;
+
+        //- Interpolate gradient
+        TypeGrad interpolateGrad
+        (
+            const point position,
+            const tetIndices& tetIs
+        ) const;
+
+        //- Calculate the average
+        void average();
+        void average(const AveragingMethod<scalar>& weight);
+
+        //- Return an internal field of the average
+        tmp<Field<Type> > internalField() const;
+
+        //- Return an internal field of the gradient
+        tmp<Field<TypeGrad> > internalFieldGrad() const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace AveragingMethods
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "Dual.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Moment/Moment.C b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Moment/Moment.C
new file mode 100644
index 0000000000000000000000000000000000000000..a71e746a1d2b781358ffaf87dec32d381ba1462c
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Moment/Moment.C
@@ -0,0 +1,207 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "Moment.H"
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class Type>
+Foam::AveragingMethods::Moment<Type>::Moment
+(
+    const IOobject& io,
+    const dictionary& dict,
+    const fvMesh& mesh
+)
+:
+    AveragingMethod<Type>(io, dict, mesh, labelList(4, mesh.nCells())),
+    data_(FieldField<Field, Type>::operator[](0)),
+    dataX_(FieldField<Field, Type>::operator[](1)),
+    dataY_(FieldField<Field, Type>::operator[](2)),
+    dataZ_(FieldField<Field, Type>::operator[](3)),
+    transform_(mesh.nCells(), symmTensor::zero),
+    scale_(0.5*pow(mesh.V(), 1.0/3.0))
+{
+    scalar a = 1.0/24.0;
+    scalar b = 0.5854101966249685;
+    scalar c = 0.1381966011250105;
+
+    scalarField wQ(4);
+    wQ[0] = a;
+    wQ[1] = a;
+    wQ[2] = a;
+    wQ[3] = a;
+
+    vectorField xQ(4);
+    xQ[0] = vector(b, c, c);
+    xQ[1] = vector(c, b, c);
+    xQ[2] = vector(c, c, b);
+    xQ[3] = vector(c, c, c);
+
+    forAll(mesh.C(), cellI)
+    {
+        const List<tetIndices> cellTets =
+            polyMeshTetDecomposition::cellTetIndices(mesh, cellI);
+
+        symmTensor A(symmTensor::zero);
+
+        forAll(cellTets, tetI)
+        {
+            const tetIndices& tetIs = cellTets[tetI];
+            const label faceI = tetIs.face();
+            const face& f = mesh.faces()[faceI];
+
+            const tensor T
+            (
+                tensor
+                (
+                    mesh.points()[f[tetIs.faceBasePt()]] - mesh.C()[cellI],
+                    mesh.points()[f[tetIs.facePtA()]] - mesh.C()[cellI],
+                    mesh.points()[f[tetIs.facePtB()]] - mesh.C()[cellI]
+                ).T()
+            );
+
+            const vectorField d((T & xQ)/scale_[cellI]);
+
+            const scalar v(6.0*tetIs.tet(mesh).mag()/mesh.V()[cellI]);
+
+            A += v*sum(wQ*sqr(d));
+        }
+
+        transform_[cellI] = inv(A);
+    }
+}
+
+
+template<class Type>
+Foam::AveragingMethods::Moment<Type>::Moment
+(
+    const Moment<Type>& am
+)
+:
+    AveragingMethod<Type>(am),
+    data_(FieldField<Field, Type>::operator[](0)),
+    dataX_(FieldField<Field, Type>::operator[](1)),
+    dataY_(FieldField<Field, Type>::operator[](2)),
+    dataZ_(FieldField<Field, Type>::operator[](3)),
+    transform_(am.transform_)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class Type>
+Foam::AveragingMethods::Moment<Type>::~Moment()
+{}
+
+
+// * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
+
+template<class Type>
+void Foam::AveragingMethods::Moment<Type>::updateGrad()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class Type>
+void Foam::AveragingMethods::Moment<Type>::add
+(
+    const point position,
+    const tetIndices& tetIs,
+    const Type& value
+)
+{
+    const label cellI = tetIs.cell();
+
+    const Type v = value/this->mesh_.V()[cellI];
+    const TypeGrad dv =
+        transform_[cellI]
+      & (
+            v
+          * (position - this->mesh_.C()[cellI])
+          / scale_[cellI]
+        );
+
+    data_[cellI] += v;
+    dataX_[cellI] += v + dv.x();
+    dataY_[cellI] += v + dv.y();
+    dataZ_[cellI] += v + dv.z();
+}
+
+
+template<class Type>
+Type Foam::AveragingMethods::Moment<Type>::interpolate
+(
+    const point position,
+    const tetIndices& tetIs
+) const
+{
+    const label cellI = tetIs.cell();
+
+    return
+        data_[cellI]
+      + (
+            TypeGrad
+            (
+                dataX_[cellI] - data_[cellI],
+                dataY_[cellI] - data_[cellI],
+                dataZ_[cellI] - data_[cellI]
+            )
+          & (position - this->mesh_.C()[cellI])
+          / scale_[cellI]
+        );
+}
+
+
+template<class Type>
+typename Foam::AveragingMethods::Moment<Type>::TypeGrad
+Foam::AveragingMethods::Moment<Type>::interpolateGrad
+(
+    const point position,
+    const tetIndices& tetIs
+) const
+{
+    const label cellI(tetIs.cell());
+
+    return
+        TypeGrad
+        (
+            dataX_[cellI] - data_[cellI],
+            dataY_[cellI] - data_[cellI],
+            dataZ_[cellI] - data_[cellI]
+        )/scale_[cellI];
+}
+
+
+template<class Type>
+Foam::tmp<Foam::Field<Type> >
+Foam::AveragingMethods::Moment<Type>::internalField() const
+{
+    return tmp<Field<Type> >(data_);
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Moment/Moment.H b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Moment/Moment.H
new file mode 100644
index 0000000000000000000000000000000000000000..67aec06b5823b462aa6c0d5aad872336d93e06a9
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Moment/Moment.H
@@ -0,0 +1,183 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::AveragingMethods::Moment
+
+Description
+    Moment lagrangian averaging procedure.
+
+    Point values and moments from the cell centroid are summed over
+    computational cells. A linear function is generated which has the same
+    integrated moment as that of the point data.
+
+    The computed linear function is used to interpolate values within a cell.
+    The gradient is calculated from the coefficients of the function, and is
+    assumed constant over the cell.
+
+SourceFiles
+    Moment.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef Moment_H
+#define Moment_H
+
+#include "AveragingMethod.H"
+#include "pointMesh.H"
+#include "tetIndices.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace AveragingMethods
+{
+
+/*---------------------------------------------------------------------------*\
+                        Class Moment Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class Type>
+class Moment
+:
+    public AveragingMethod<Type>
+{
+public:
+
+    //- Public typedefs
+
+        //- Gradient type
+        typedef typename AveragingMethod<Type>::TypeGrad TypeGrad;
+
+
+private:
+
+    //- Private data
+
+        //- Data mean
+        Field<Type>& data_;
+
+        //- X-data moment
+        Field<Type>& dataX_;
+
+        //- Y-data moment
+        Field<Type>& dataY_;
+
+        //- Z-data moment
+        Field<Type>& dataZ_;
+
+        //- Transform tensor from moment to gradient
+        Field<symmTensor> transform_;
+
+        //- Length scale for moment values
+        Field<scalar> scale_;
+
+
+    //- Private member functions
+
+        //- Re-calculate gradient
+        virtual void updateGrad();
+
+
+public:
+
+    //- Runtime type information
+    TypeName("moment");
+
+
+    //- Constructors
+
+        //- Construct from components
+        Moment
+        (
+            const IOobject& io,
+            const dictionary& dict,
+            const fvMesh &mesh
+        );
+
+        //- Construct a copy
+        Moment(const Moment<Type>& am);
+
+        //- Construct and return a clone
+        virtual autoPtr<AveragingMethod<Type> > clone() const
+        {
+            return autoPtr<AveragingMethod<Type> >
+            (
+                new Moment<Type>(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~Moment();
+
+
+    //- Member Functions
+
+        //- Add point value to interpolation
+        void add
+        (
+            const point position,
+            const tetIndices& tetIs,
+            const Type& value
+        );
+
+        //- Interpolate
+        Type interpolate
+        (
+            const point position,
+            const tetIndices& tetIs
+        ) const;
+
+        //- Interpolate gradient
+        TypeGrad interpolateGrad
+        (
+            const point position,
+            const tetIndices& tetIs
+        ) const;
+
+        //- Return an internal field of the average
+        tmp<Field<Type> > internalField() const;
+
+        //- Return an internal field of the gradient
+        tmp<Field<TypeGrad> > internalFieldGrad() const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace AveragingMethods
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "Moment.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/makeAveragingMethods.C b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/makeAveragingMethods.C
new file mode 100644
index 0000000000000000000000000000000000000000..c421ab9cb83f8e2b7d5829ff811c7948add5b818
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/makeAveragingMethods.C
@@ -0,0 +1,89 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "fvCFD.H"
+#include "polyMeshTetDecomposition.H"
+
+#include "Basic.H"
+#include "Dual.H"
+#include "Moment.H"
+
+namespace Foam
+{
+    // Scalar interpolation
+    defineNamedTemplateTypeNameAndDebug(AveragingMethod<scalar>, 0);
+    defineTemplateRunTimeSelectionTable
+    (
+        AveragingMethod<scalar>,
+        dictionary
+    );
+
+    // Vector interpolation
+    defineNamedTemplateTypeNameAndDebug(AveragingMethod<vector>, 0);
+    defineTemplateRunTimeSelectionTable
+    (
+        AveragingMethod<vector>,
+        dictionary
+    );
+
+    namespace AveragingMethods
+    {
+        // Basic interpolation
+        defineNamedTemplateTypeNameAndDebug(Basic<scalar>, 0);
+        AveragingMethod<scalar>::
+            adddictionaryConstructorToTable<Basic<scalar> >
+            addBasicscalarConstructorToTable_;
+
+        defineNamedTemplateTypeNameAndDebug(Basic<vector>, 0);
+        AveragingMethod<vector>::
+            adddictionaryConstructorToTable<Basic<vector> >
+            addBasicvectorConstructorToTable_;
+
+        // Dual interpolation
+        defineNamedTemplateTypeNameAndDebug(Dual<scalar>, 0);
+        AveragingMethod<scalar>::
+            adddictionaryConstructorToTable<Dual<scalar> >
+            addDualscalarConstructorToTable_;
+
+        defineNamedTemplateTypeNameAndDebug(Dual<vector>, 0);
+        AveragingMethod<vector>::
+            adddictionaryConstructorToTable<Dual<vector> >
+            addDualvectorConstructorToTable_;
+
+        // Moment interpolation
+        defineNamedTemplateTypeNameAndDebug(Moment<scalar>, 0);
+        AveragingMethod<scalar>::
+            adddictionaryConstructorToTable<Moment<scalar> >
+            addMomentscalarConstructorToTable_;
+
+        defineNamedTemplateTypeNameAndDebug(Moment<vector>, 0);
+        AveragingMethod<vector>::
+            adddictionaryConstructorToTable<Moment<vector> >
+            addMomentvectorConstructorToTable_;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/CorrectionLimitingMethod/CorrectionLimitingMethod.C b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/CorrectionLimitingMethod/CorrectionLimitingMethod.C
new file mode 100644
index 0000000000000000000000000000000000000000..84545e76405f5de1e3b89780ceb71c9ef72a3efd
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/CorrectionLimitingMethod/CorrectionLimitingMethod.C
@@ -0,0 +1,92 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "CorrectionLimitingMethod.H"
+
+namespace Foam
+{
+    defineTypeNameAndDebug(CorrectionLimitingMethod, 0);
+    defineRunTimeSelectionTable(CorrectionLimitingMethod, dictionary);
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::CorrectionLimitingMethod::CorrectionLimitingMethod
+(
+    const dictionary& dict
+)
+{}
+
+
+Foam::CorrectionLimitingMethod::CorrectionLimitingMethod
+(
+    const CorrectionLimitingMethod& cl
+)
+{}
+
+
+// * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * * //
+
+Foam::autoPtr<Foam::CorrectionLimitingMethod>
+Foam::CorrectionLimitingMethod::New
+(
+    const dictionary& dict
+)
+{
+    word modelType(dict.lookup("type"));
+
+    Info<< "Selecting correction limiter " << modelType << endl;
+
+    dictionaryConstructorTable::iterator cstrIter =
+        dictionaryConstructorTablePtr_->find(modelType);
+
+    if (cstrIter == dictionaryConstructorTablePtr_->end())
+    {
+        FatalErrorIn
+        (
+            "CorrectionLimitingMethod::New"
+            "("
+                "const word&, "
+                "const dictionary&"
+            ")"
+        )   << "Unknown correction limiter type " << modelType
+            << ", constructor not in hash table" << nl << nl
+            << "    Valid correction limiter types are:" << nl
+            << dictionaryConstructorTablePtr_->sortedToc()
+            << abort(FatalError);
+    }
+
+    return autoPtr<CorrectionLimitingMethod>(cstrIter()(dict));
+}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+Foam::CorrectionLimitingMethod::~CorrectionLimitingMethod()
+{}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/CorrectionLimitingMethod/CorrectionLimitingMethod.H b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/CorrectionLimitingMethod/CorrectionLimitingMethod.H
new file mode 100644
index 0000000000000000000000000000000000000000..a478d47e91288df69fa09ce704a65ab5cc0a2027
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/CorrectionLimitingMethod/CorrectionLimitingMethod.H
@@ -0,0 +1,120 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::CorrectionLimitingMethod
+
+Description
+    Base class for correction limiting methods.
+
+SourceFiles
+    CorrectionLimitingMethod.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef CorrectionLimitingMethod_H
+#define CorrectionLimitingMethod_H
+
+#include "fvCFD.H"
+#include "dictionary.H"
+#include "runTimeSelectionTables.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+/*---------------------------------------------------------------------------*\
+                         Class CorrectionLimitingMethod Declaration
+\*---------------------------------------------------------------------------*/
+
+class CorrectionLimitingMethod
+{
+private:
+
+    // Private Member Functions
+
+        //- Disallow default bitwise assignment
+        void operator=(const CorrectionLimitingMethod&);
+
+
+public:
+
+    //- Runtime type information
+    TypeName("correctionLimitingMethod");
+
+    //- Declare runtime constructor selection table
+    declareRunTimeSelectionTable
+    (
+        autoPtr,
+        CorrectionLimitingMethod,
+        dictionary,
+        (const dictionary& dict),
+        (dict)
+    );
+
+
+    // Constructors
+
+        //- Construct from components
+        CorrectionLimitingMethod(const dictionary& dict);
+
+        //- Construct as copy
+        CorrectionLimitingMethod(const CorrectionLimitingMethod& cl);
+
+        //- Construct and return a clone
+        virtual autoPtr<CorrectionLimitingMethod> clone() const = 0;
+
+
+    //- Selector
+    static autoPtr<CorrectionLimitingMethod> New
+    (
+        const dictionary& dict
+    );
+
+
+    //- Destructor
+    virtual ~CorrectionLimitingMethod();
+
+
+    // Member Functions
+
+        //- Return the limited velocity
+        virtual vector limitedVelocity
+        (
+            const vector uP,
+            const vector dU,
+            const vector uMean
+        ) const = 0;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/absolute/absolute.C b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/absolute/absolute.C
new file mode 100644
index 0000000000000000000000000000000000000000..890e74f720cdd24c47f1817cb46e423e0506cc65
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/absolute/absolute.C
@@ -0,0 +1,86 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "absolute.H"
+#include "addToRunTimeSelectionTable.H"
+
+namespace Foam
+{
+namespace CorrectionLimitingMethods
+{
+    defineTypeNameAndDebug(absolute, 0);
+
+    addToRunTimeSelectionTable
+    (
+        CorrectionLimitingMethod,
+        absolute,
+        dictionary
+    );
+}
+}
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::CorrectionLimitingMethods::absolute::absolute(const dictionary& dict)
+:
+    CorrectionLimitingMethod(dict),
+    e_(readScalar(dict.lookup("e")))
+{}
+
+
+Foam::CorrectionLimitingMethods::absolute::absolute(const absolute& cl)
+:
+    CorrectionLimitingMethod(cl),
+    e_(cl.e_)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+Foam::CorrectionLimitingMethods::absolute::~absolute()
+{}
+
+
+// * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
+
+Foam::vector Foam::CorrectionLimitingMethods::absolute::limitedVelocity
+(
+    const vector uP,
+    const vector dU,
+    const vector uMean
+) const
+{
+    const vector uRelative = uP - uMean;
+
+    return minMod
+    (
+        dU,
+      - (1.0 + this->e_)*uRelative
+       *mag(uP)/max(mag(uRelative), SMALL)
+    );
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/absolute/absolute.H b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/absolute/absolute.H
new file mode 100644
index 0000000000000000000000000000000000000000..637d99ec44de17f60879b17a13ca121f1c2c7a15
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/absolute/absolute.H
@@ -0,0 +1,117 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::CorrectionLimitingMethods::absolute
+
+Description
+    Correction limiting method based on the absolute particle velocity.
+
+    This method that limits the velocity correction to that of a rebound with a
+    coefficient of restitution \f$e\f$. The absolute velocity of the particle
+    is used when calculating the magnitude of the limited correction.
+    The direction is calculated using the relative velocity.
+
+SourceFiles
+    absolute.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef absolute_H
+#define absolute_H
+
+#include "CorrectionLimitingMethod.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace CorrectionLimitingMethods
+{
+
+/*---------------------------------------------------------------------------*\
+                         Class absolute Declaration
+\*---------------------------------------------------------------------------*/
+
+class absolute
+:
+    public CorrectionLimitingMethod
+{
+protected:
+
+    // Protected data
+
+        //- Coefficient of restitution
+        scalar e_;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("absolute");
+
+
+    // Constructors
+
+        //- Construct from components
+        absolute(const dictionary& dict);
+
+        //- Construct as copy
+        absolute(const absolute& cl);
+
+        //- Construct and return a clone
+        virtual autoPtr<CorrectionLimitingMethod> clone() const
+        {
+            return autoPtr<CorrectionLimitingMethod>
+            (
+                new absolute(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~absolute();
+
+
+    // Member Functions
+
+        //- Return the limited velocity
+        virtual vector limitedVelocity
+        (
+            const vector uP,
+            const vector dU,
+            const vector uMean
+        ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace CorrectionLimitingMethods
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/noCorrectionLimiting/noCorrectionLimiting.C b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/noCorrectionLimiting/noCorrectionLimiting.C
new file mode 100644
index 0000000000000000000000000000000000000000..9e05dce0c05cf8b3015cb58b73a65a1fbfd3aea6
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/noCorrectionLimiting/noCorrectionLimiting.C
@@ -0,0 +1,84 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "noCorrectionLimiting.H"
+#include "addToRunTimeSelectionTable.H"
+
+namespace Foam
+{
+namespace CorrectionLimitingMethods
+{
+    defineTypeNameAndDebug(noCorrectionLimiting, 0);
+
+    addToRunTimeSelectionTable
+    (
+        CorrectionLimitingMethod,
+        noCorrectionLimiting,
+        dictionary
+    );
+}
+}
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::CorrectionLimitingMethods::noCorrectionLimiting::noCorrectionLimiting
+(
+    const dictionary& dict
+)
+:
+    CorrectionLimitingMethod(dict)
+{}
+
+
+Foam::CorrectionLimitingMethods::noCorrectionLimiting::noCorrectionLimiting
+(
+    const noCorrectionLimiting& cl
+)
+:
+    CorrectionLimitingMethod(cl)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+Foam::CorrectionLimitingMethods::noCorrectionLimiting::~noCorrectionLimiting()
+{}
+
+
+// * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
+
+Foam::vector
+Foam::CorrectionLimitingMethods::noCorrectionLimiting::limitedVelocity
+(
+    const vector uP,
+    const vector dU,
+    const vector uMean
+) const
+{
+    return dU;
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/noCorrectionLimiting/noCorrectionLimiting.H b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/noCorrectionLimiting/noCorrectionLimiting.H
new file mode 100644
index 0000000000000000000000000000000000000000..b1656e20435adb1c365bedbe3ba312152ed40dc3
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/noCorrectionLimiting/noCorrectionLimiting.H
@@ -0,0 +1,103 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::CorrectionLimitingMethods::noCorrectionLimiting
+
+Description
+
+SourceFiles
+    noCorrectionLimiting.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef noCorrectionLimiting_H
+#define noCorrectionLimiting_H
+
+#include "CorrectionLimitingMethod.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace CorrectionLimitingMethods
+{
+
+/*---------------------------------------------------------------------------*\
+                         Class noCorrectionLimiting Declaration
+\*---------------------------------------------------------------------------*/
+
+class noCorrectionLimiting
+:
+    public CorrectionLimitingMethod
+{
+public:
+
+    //- Runtime type information
+    TypeName("none");
+
+
+    // Constructors
+
+        //- Construct from components
+        noCorrectionLimiting(const dictionary& dict);
+
+        //- Construct as copy
+        noCorrectionLimiting(const noCorrectionLimiting& cl);
+
+        //- Construct and return a clone
+        virtual autoPtr<CorrectionLimitingMethod> clone() const
+        {
+            return autoPtr<CorrectionLimitingMethod>
+            (
+                new noCorrectionLimiting(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~noCorrectionLimiting();
+
+
+    // Member Functions
+
+        //- Return the limited velocity
+        virtual vector limitedVelocity
+        (
+            const vector uP,
+            const vector dU,
+            const vector uMean
+        ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace CorrectionLimitingMethods
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/relative/relative.C b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/relative/relative.C
new file mode 100644
index 0000000000000000000000000000000000000000..a863ae5655f32765fe4410c3cbfee8f8ec7c5df4
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/relative/relative.C
@@ -0,0 +1,85 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "relative.H"
+#include "addToRunTimeSelectionTable.H"
+
+namespace Foam
+{
+namespace CorrectionLimitingMethods
+{
+    defineTypeNameAndDebug(relative, 0);
+
+    addToRunTimeSelectionTable
+    (
+        CorrectionLimitingMethod,
+        relative,
+        dictionary
+    );
+}
+}
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::CorrectionLimitingMethods::relative::relative(const dictionary& dict)
+:
+    CorrectionLimitingMethod(dict),
+    e_(readScalar(dict.lookup("e")))
+{}
+
+
+Foam::CorrectionLimitingMethods::relative::relative(const relative& cl)
+:
+    CorrectionLimitingMethod(cl),
+    e_(cl.e_)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+Foam::CorrectionLimitingMethods::relative::~relative()
+{}
+
+
+// * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
+
+Foam::vector Foam::CorrectionLimitingMethods::relative::limitedVelocity
+(
+    const vector uP,
+    const vector dU,
+    const vector uMean
+) const
+{
+    const vector uRelative = uP - uMean;
+
+    return minMod
+    (
+        dU,
+      - (1.0 + this->e_)*uRelative
+    );
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/relative/relative.H b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/relative/relative.H
new file mode 100644
index 0000000000000000000000000000000000000000..0d84e4eb395d65ab70229c07b3dce76570e58abf
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/relative/relative.H
@@ -0,0 +1,117 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::CorrectionLimitingMethods::relative
+
+Description
+    Correction limiting method based on the relative particle velocity.
+
+    This method limits the velocity correction to that of a rebound with a
+    coefficient of restitution \f$e\f$. The relative velocity of the particle
+    with respect to the mean value is used to calculate the direction and
+    magnitude of the limited velocity.
+
+SourceFiles
+    relative.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef relative_H
+#define relative_H
+
+#include "CorrectionLimitingMethod.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace CorrectionLimitingMethods
+{
+
+/*---------------------------------------------------------------------------*\
+                         Class relative Declaration
+\*---------------------------------------------------------------------------*/
+
+class relative
+:
+    public CorrectionLimitingMethod
+{
+protected:
+
+    // Protected data
+
+        //- Coefficient of restitution
+        scalar e_;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("relative");
+
+
+    // Constructors
+
+        //- Construct from components
+        relative(const dictionary& dict);
+
+        //- Construct as copy
+        relative(const relative& cl);
+
+        //- Construct and return a clone
+        virtual autoPtr<CorrectionLimitingMethod> clone() const
+        {
+            return autoPtr<CorrectionLimitingMethod>
+            (
+                new relative(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~relative();
+
+
+    // Member Functions
+
+        //- Return the limited velocity
+        virtual vector limitedVelocity
+        (
+            const vector uP,
+            const vector dU,
+            const vector uMean
+        ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace CorrectionLimitingMethods
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/DampingModel/DampingModel.C b/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/DampingModel/DampingModel.C
new file mode 100644
index 0000000000000000000000000000000000000000..c91831966e85e16284dff726e0b9f5fcd449b245
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/DampingModel/DampingModel.C
@@ -0,0 +1,114 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "DampingModel.H"
+#include "TimeScaleModel.H"
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::DampingModel<CloudType>::DampingModel(CloudType& owner)
+:
+    CloudSubModelBase<CloudType>(owner),
+    timeScaleModel_(NULL)
+{}
+
+
+template<class CloudType>
+Foam::DampingModel<CloudType>::DampingModel
+(
+    const dictionary& dict,
+    CloudType& owner,
+    const word& type
+)
+:
+    CloudSubModelBase<CloudType>(owner, dict, typeName, type),
+    timeScaleModel_
+    (
+        TimeScaleModel::New
+        (
+            this->coeffDict().subDict(TimeScaleModel::typeName)
+        )
+    )
+{}
+
+
+template<class CloudType>
+Foam::DampingModel<CloudType>::DampingModel(const DampingModel<CloudType>& cm)
+:
+    CloudSubModelBase<CloudType>(cm),
+    timeScaleModel_(cm.timeScaleModel_)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::DampingModel<CloudType>::~DampingModel()
+{}
+
+
+// * * * * * * * * * * * * * * * *  Selector * * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::autoPtr<Foam::DampingModel<CloudType> >
+Foam::DampingModel<CloudType>::New
+(
+    const dictionary& dict,
+    CloudType& owner
+)
+{
+    word modelType(dict.lookup(typeName));
+
+    Info<< "Selecting damping model " << modelType << endl;
+
+    typename dictionaryConstructorTable::iterator cstrIter =
+        dictionaryConstructorTablePtr_->find(modelType);
+
+    if (cstrIter == dictionaryConstructorTablePtr_->end())
+    {
+        FatalErrorIn
+        (
+            "DampingModel<CloudType>::New"
+            "("
+                "const dictionary&, "
+                "CloudType&"
+            ")"
+        )   << "Unknown damping model type " << modelType
+            << ", constructor not in hash table" << nl << nl
+            << "    Valid damping model types are:" << nl
+            << dictionaryConstructorTablePtr_->sortedToc()
+            << exit(FatalError);
+    }
+
+    return
+        autoPtr<DampingModel<CloudType> >
+        (
+            cstrIter()(dict, owner)
+        );
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/DampingModel/DampingModel.H b/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/DampingModel/DampingModel.H
new file mode 100644
index 0000000000000000000000000000000000000000..79edceeb9c6ef767b18902a45430711b4b783781
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/DampingModel/DampingModel.H
@@ -0,0 +1,173 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::DampingModel
+
+Description
+    Base class for collisional damping models.
+
+SourceFiles
+    DampingModel.C
+    DampingModelNew.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef DampingModel_H
+#define DampingModel_H
+
+#include "IOdictionary.H"
+#include "autoPtr.H"
+#include "runTimeSelectionTables.H"
+#include "CloudSubModelBase.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+// Forward declaration of classes
+
+class TimeScaleModel;
+
+/*---------------------------------------------------------------------------*\
+                         Class DampingModel Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class CloudType>
+class DampingModel
+:
+    public CloudSubModelBase<CloudType>
+{
+protected:
+
+    // Protected data
+
+        //- Time scale model
+        autoPtr<TimeScaleModel> timeScaleModel_;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("dampingModel");
+
+    //- Declare runtime constructor selection table
+    declareRunTimeSelectionTable
+    (
+        autoPtr,
+        DampingModel,
+        dictionary,
+        (
+            const dictionary& dict,
+            CloudType& owner
+        ),
+        (dict, owner)
+    );
+
+
+    // Constructors
+
+        //- Construct null from owner
+        DampingModel(CloudType& owner);
+
+        //- Construct from components
+        DampingModel
+        (
+            const dictionary& dict,
+            CloudType& owner,
+            const word& type
+        );
+
+        //- Construct copy
+        DampingModel(const DampingModel<CloudType>& cm);
+
+        //- Construct and return a clone
+        virtual autoPtr<DampingModel<CloudType> > clone() const = 0;
+
+
+    //- Destructor
+    virtual ~DampingModel();
+
+
+    //- Selector
+    static autoPtr<DampingModel<CloudType> > New
+    (
+        const dictionary& dict,
+        CloudType& owner
+    );
+
+
+    // Member Functions
+
+        //- Calculate the velocity correction
+        virtual vector velocityCorrection
+        (
+            typename CloudType::parcelType& p,
+            const scalar deltaT
+        ) const = 0;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#define makeDampingModel(CloudType)                                            \
+                                                                               \
+    typedef CloudType::MPPICCloudType MPPICCloudType;                          \
+    defineNamedTemplateTypeNameAndDebug                                        \
+    (                                                                          \
+        DampingModel<MPPICCloudType>,                                          \
+        0                                                                      \
+    );                                                                         \
+    defineTemplateRunTimeSelectionTable                                        \
+    (                                                                          \
+        DampingModel<MPPICCloudType>,                                          \
+        dictionary                                                             \
+    );
+
+
+#define makeDampingModelType(SS, CloudType)                                    \
+                                                                               \
+    typedef CloudType::MPPICCloudType MPPICCloudType;                          \
+    defineNamedTemplateTypeNameAndDebug(SS<MPPICCloudType>, 0);                \
+                                                                               \
+    DampingModel<MPPICCloudType>::                                             \
+        adddictionaryConstructorToTable<SS<MPPICCloudType> >                   \
+            add##SS##CloudType##MPPICCloudType##ConstructorToTable_;
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "DampingModel.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/NoDamping/NoDamping.C b/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/NoDamping/NoDamping.C
new file mode 100644
index 0000000000000000000000000000000000000000..c49bf78aa53c28cee404fdbc2281bb9aa10e29d8
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/NoDamping/NoDamping.C
@@ -0,0 +1,77 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "NoDamping.H"
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::DampingModels::NoDamping<CloudType>::NoDamping
+(
+    const dictionary& dict,
+    CloudType& owner
+)
+:
+    DampingModel<CloudType>(owner)
+{}
+
+
+template<class CloudType>
+Foam::DampingModels::NoDamping<CloudType>::NoDamping
+(
+    const NoDamping<CloudType>& cm
+)
+:
+    DampingModel<CloudType>(cm)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::DampingModels::NoDamping<CloudType>::~NoDamping()
+{}
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::vector Foam::DampingModels::NoDamping<CloudType>::velocityCorrection
+(
+    typename CloudType::parcelType& p,
+    const scalar deltaT
+) const
+{
+    return vector::zero;
+}
+
+
+template<class CloudType>
+bool Foam::DampingModels::NoDamping<CloudType>::active() const
+{
+    return false;
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/NoDamping/NoDamping.H b/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/NoDamping/NoDamping.H
new file mode 100644
index 0000000000000000000000000000000000000000..34f2b9a967fc86d8da824667d3f6faa20faf622c
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/NoDamping/NoDamping.H
@@ -0,0 +1,111 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::DampingModels::NoDamping
+
+Description
+
+SourceFiles
+    NoDamping.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef NoDamping_H
+#define NoDamping_H
+
+#include "DampingModel.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace DampingModels
+{
+
+/*---------------------------------------------------------------------------*\
+                         Class NoDamping Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class CloudType>
+class NoDamping
+:
+    public DampingModel<CloudType>
+{
+public:
+
+    //- Runtime type information
+    TypeName("none");
+
+    // Constructors
+
+        //- Construct from components
+        NoDamping(const dictionary& dict, CloudType& owner);
+
+        //- Construct copy
+        NoDamping(const NoDamping<CloudType>& cm);
+
+        //- Construct and return a clone
+        virtual autoPtr<DampingModel<CloudType> > clone() const
+        {
+            return autoPtr<DampingModel<CloudType> >
+            (
+                new NoDamping<CloudType>(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~NoDamping();
+
+
+    //- Member Functions
+
+        //- Calculate the velocity correction
+        virtual vector velocityCorrection
+        (
+            typename CloudType::parcelType& p,
+            const scalar deltaT
+        ) const;
+
+        //- Return the model 'active' status
+        virtual bool active() const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace DampingModels
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "NoDamping.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/Relaxation/Relaxation.C b/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/Relaxation/Relaxation.C
new file mode 100644
index 0000000000000000000000000000000000000000..fadd26c67faba234322fd0180a1287f29dedd3cc
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/Relaxation/Relaxation.C
@@ -0,0 +1,154 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "Relaxation.H"
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::DampingModels::Relaxation<CloudType>::Relaxation
+(
+    const dictionary& dict,
+    CloudType& owner
+)
+:
+    DampingModel<CloudType>(dict, owner, typeName),
+    uAverage_(NULL),
+    oneByTimeScaleAverage_(NULL)
+{}
+
+
+template<class CloudType>
+Foam::DampingModels::Relaxation<CloudType>::Relaxation
+(
+    const Relaxation<CloudType>& cm
+)
+:
+    DampingModel<CloudType>(cm),
+    uAverage_(NULL),
+    oneByTimeScaleAverage_(cm.oneByTimeScaleAverage_->clone())
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::DampingModels::Relaxation<CloudType>::
+~Relaxation()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class CloudType>
+void Foam::DampingModels::Relaxation<CloudType>::cacheFields(const bool store)
+{
+    if (store)
+    {
+        const fvMesh& mesh = this->owner().mesh();
+        const word& cloudName = this->owner().name();
+
+        const AveragingMethod<scalar>& volumeAverage =
+            mesh.lookupObject<AveragingMethod<scalar> >
+            (
+                cloudName + ":volumeAverage"
+            );
+        const AveragingMethod<scalar>& radiusAverage =
+            mesh.lookupObject<AveragingMethod<scalar> >
+            (
+                cloudName + ":radiusAverage"
+            );
+        const AveragingMethod<vector>& uAverage =
+            mesh.lookupObject<AveragingMethod<vector> >
+            (
+                cloudName + ":uAverage"
+            );
+        const AveragingMethod<scalar>& uSqrAverage =
+            mesh.lookupObject<AveragingMethod<scalar> >
+            (
+                cloudName + ":uSqrAverage"
+            );
+        const AveragingMethod<scalar>& frequencyAverage =
+            mesh.lookupObject<AveragingMethod<scalar> >
+            (
+                cloudName + ":frequencyAverage"
+            );
+
+        uAverage_ = &uAverage;
+
+        oneByTimeScaleAverage_.reset
+        (
+            AveragingMethod<scalar>::New
+            (
+                IOobject
+                (
+                    cloudName + ":oneByTimeScaleAverage",
+                    this->owner().db().time().timeName(),
+                    mesh
+                ),
+                this->owner().solution().dict(),
+                mesh
+            ).ptr()
+        );
+
+        oneByTimeScaleAverage_() =
+        (
+            this->timeScaleModel_->oneByTau
+            (
+                volumeAverage,
+                radiusAverage,
+                uSqrAverage,
+                frequencyAverage
+            )
+        )();
+    }
+    else
+    {
+        uAverage_ = NULL;
+        oneByTimeScaleAverage_.clear();
+    }
+}
+
+
+template<class CloudType>
+Foam::vector Foam::DampingModels::Relaxation<CloudType>::velocityCorrection
+(
+    typename CloudType::parcelType& p,
+    const scalar deltaT
+) const
+{
+    const tetIndices
+        tetIs(p.cell(), p.tetFace(), p.tetPt(), this->owner().mesh());
+
+    const scalar x =
+        deltaT*oneByTimeScaleAverage_->interpolate(p.position(), tetIs);
+
+    const vector u = uAverage_->interpolate(p.position(), tetIs);
+
+    return (u - p.U())*x/(x + 2.0);
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/Relaxation/Relaxation.H b/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/Relaxation/Relaxation.H
new file mode 100644
index 0000000000000000000000000000000000000000..d9f6e07e5785c5a9acda7d6a2748f151cd7c75cf
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/Relaxation/Relaxation.H
@@ -0,0 +1,135 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::DampingModels::Relaxation
+
+Description
+    Relaxation collisional damping model.
+
+    Particle velocities are relaxed towards the local mean over a time-scale.
+
+    Reference:
+    \verbatim
+        "An improved collision damping time for MP-PIC calculations of dense
+        particle flows with applications to polydisperse sedimenting beds and
+        colliding particle jets"
+        P O'Rourke and D Snider
+        Chemical Engineering Science
+        Volume 65, Issue 22, Pages 6014-6028, November 2010
+    \endverbatim
+
+SourceFiles
+    Relaxation.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef Relaxation_H
+#define Relaxation_H
+
+#include "DampingModel.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace DampingModels
+{
+
+/*---------------------------------------------------------------------------*\
+                         Class Relaxation Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class CloudType>
+class Relaxation
+:
+    public DampingModel<CloudType>
+{
+private:
+
+    // Private data
+
+        //- Velocity average
+        const AveragingMethod<vector>* uAverage_;
+
+        //- Reciprocal of the time scale average
+        autoPtr<AveragingMethod<scalar> > oneByTimeScaleAverage_;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("relaxation");
+
+    // Constructors
+
+        //- Construct from components
+        Relaxation(const dictionary& dict, CloudType& owner);
+
+        //- Construct copy
+        Relaxation(const Relaxation<CloudType>& cm);
+
+        //- Construct and return a clone
+        virtual autoPtr<DampingModel<CloudType> > clone() const
+        {
+            return autoPtr<DampingModel<CloudType> >
+            (
+                new Relaxation<CloudType>(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~Relaxation();
+
+
+    //- Member Functions
+
+        //- Calculate the damping time scales
+        virtual void cacheFields(const bool store);
+
+        //- Calculate the velocity correction
+        virtual vector velocityCorrection
+        (
+            typename CloudType::parcelType& p,
+            const scalar deltaT
+        ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace DampingModels
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "Relaxation.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/IsotropyModel/IsotropyModel.C b/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/IsotropyModel/IsotropyModel.C
new file mode 100644
index 0000000000000000000000000000000000000000..da454553cfc39547b1a366773f8a89c3126103ea
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/IsotropyModel/IsotropyModel.C
@@ -0,0 +1,118 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "IsotropyModel.H"
+
+#include "TimeScaleModel.H"
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::IsotropyModel<CloudType>::IsotropyModel(CloudType& owner)
+:
+    CloudSubModelBase<CloudType>(owner),
+    timeScaleModel_(NULL)
+{}
+
+
+template<class CloudType>
+Foam::IsotropyModel<CloudType>::IsotropyModel
+(
+    const dictionary& dict,
+    CloudType& owner,
+    const word& type
+)
+:
+    CloudSubModelBase<CloudType>(owner, dict, typeName, type),
+    timeScaleModel_
+    (
+        TimeScaleModel::New
+        (
+            this->coeffDict().subDict(TimeScaleModel::typeName)
+        )
+    )
+{}
+
+
+template<class CloudType>
+Foam::IsotropyModel<CloudType>::IsotropyModel
+(
+    const IsotropyModel<CloudType>& cm
+)
+:
+    CloudSubModelBase<CloudType>(cm),
+    timeScaleModel_(cm.timeScaleModel_)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::IsotropyModel<CloudType>::~IsotropyModel()
+{}
+
+
+// * * * * * * * * * * * * * * * *  Selector * * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::autoPtr<Foam::IsotropyModel<CloudType> >
+Foam::IsotropyModel<CloudType>::New
+(
+    const dictionary& dict,
+    CloudType& owner
+)
+{
+    word modelType(dict.lookup(typeName));
+
+    Info<< "Selecting isotropy model " << modelType << endl;
+
+    typename dictionaryConstructorTable::iterator cstrIter =
+        dictionaryConstructorTablePtr_->find(modelType);
+
+    if (cstrIter == dictionaryConstructorTablePtr_->end())
+    {
+        FatalErrorIn
+        (
+            "IsotropyModel<CloudType>::New"
+            "("
+                "const dictionary&, "
+                "CloudType&"
+            ")"
+        )   << "Unknown isotropy model type " << modelType
+            << ", constructor not in hash table" << nl << nl
+            << "    Valid isotropy model types are:" << nl
+            << dictionaryConstructorTablePtr_->sortedToc()
+            << exit(FatalError);
+    }
+
+    return
+        autoPtr<IsotropyModel<CloudType> >
+        (
+            cstrIter()(dict, owner)
+        );
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/IsotropyModel/IsotropyModel.H b/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/IsotropyModel/IsotropyModel.H
new file mode 100644
index 0000000000000000000000000000000000000000..08f20f1256ad931b032d7a238413880bd4d2486a
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/IsotropyModel/IsotropyModel.H
@@ -0,0 +1,167 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::IsotropyModel
+
+Description
+    Base class for collisional return-to-isotropy models.
+
+SourceFiles
+    IsotropyModel.C
+    IsotropyModelNew.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef IsotropyModel_H
+#define IsotropyModel_H
+
+#include "IOdictionary.H"
+#include "autoPtr.H"
+#include "runTimeSelectionTables.H"
+#include "CloudSubModelBase.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+// Forward declaration of classes
+
+class TimeScaleModel;
+
+/*---------------------------------------------------------------------------*\
+                         Class IsotropyModel Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class CloudType>
+class IsotropyModel
+:
+    public CloudSubModelBase<CloudType>
+{
+protected:
+
+        //- Time scale model
+        autoPtr<TimeScaleModel> timeScaleModel_;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("isotropyModel");
+
+    //- Declare runtime constructor selection table
+    declareRunTimeSelectionTable
+    (
+        autoPtr,
+        IsotropyModel,
+        dictionary,
+        (
+            const dictionary& dict,
+            CloudType& owner
+        ),
+        (dict, owner)
+    );
+
+
+    // Constructors
+
+        //- Construct null from owner
+        IsotropyModel(CloudType& owner);
+
+        //- Construct from components
+        IsotropyModel
+        (
+            const dictionary& dict,
+            CloudType& owner,
+            const word& type
+        );
+
+        //- Construct a copy
+        IsotropyModel(const IsotropyModel<CloudType>& cm);
+
+        //- Construct and return a clone
+        virtual autoPtr<IsotropyModel<CloudType> > clone() const = 0;
+
+
+    //- Destructor
+    virtual ~IsotropyModel();
+
+
+    //- Selector
+    static autoPtr<IsotropyModel<CloudType> > New
+    (
+        const dictionary& dict,
+        CloudType& owner
+    );
+
+
+    //- Member Functions
+
+        //- Calculate velocities
+        virtual void calculate() = 0;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#define makeIsotropyModel(CloudType)                                \
+                                                                              \
+    typedef CloudType::MPPICCloudType MPPICCloudType;                         \
+    defineNamedTemplateTypeNameAndDebug                                       \
+    (                                                                         \
+        IsotropyModel<MPPICCloudType>,                             \
+        0                                                                     \
+    );                                                                        \
+    defineTemplateRunTimeSelectionTable                                       \
+    (                                                                         \
+        IsotropyModel<MPPICCloudType>,                             \
+        dictionary                                                            \
+    );
+
+
+#define makeIsotropyModelType(SS, CloudType)                       \
+                                                                              \
+    typedef CloudType::MPPICCloudType MPPICCloudType;                         \
+    defineNamedTemplateTypeNameAndDebug(SS<MPPICCloudType>, 0);               \
+                                                                              \
+    IsotropyModel<MPPICCloudType>::                                \
+        adddictionaryConstructorToTable<SS<MPPICCloudType> >                  \
+            add##SS##CloudType##MPPICCloudType##ConstructorToTable_;
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "IsotropyModel.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/NoIsotropy/NoIsotropy.C b/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/NoIsotropy/NoIsotropy.C
new file mode 100644
index 0000000000000000000000000000000000000000..d8b0fb075d96b6da4dcb5ea33f49a80108e5d4d7
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/NoIsotropy/NoIsotropy.C
@@ -0,0 +1,74 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "NoIsotropy.H"
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::IsotropyModels::NoIsotropy<CloudType>::NoIsotropy
+(
+    const dictionary& dict,
+    CloudType& owner
+)
+:
+    IsotropyModel<CloudType>(owner)
+{}
+
+
+template<class CloudType>
+Foam::IsotropyModels::NoIsotropy<CloudType>::NoIsotropy
+(
+    const NoIsotropy<CloudType>& cm
+)
+:
+    IsotropyModel<CloudType>(cm)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::IsotropyModels::NoIsotropy<CloudType>::~NoIsotropy()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class CloudType>
+void Foam::IsotropyModels::NoIsotropy<CloudType>::calculate()
+{
+    // do nothing
+}
+
+
+template<class CloudType>
+bool Foam::IsotropyModels::NoIsotropy<CloudType>::active() const
+{
+    return false;
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/NoIsotropy/NoIsotropy.H b/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/NoIsotropy/NoIsotropy.H
new file mode 100644
index 0000000000000000000000000000000000000000..e5aafff43e3ca9db1b032a87a61271efd9523b87
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/NoIsotropy/NoIsotropy.H
@@ -0,0 +1,107 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::IsotropyModels::NoIsotropy
+
+Description
+
+SourceFiles
+    NoIsotropy.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef NoIsotropy_H
+#define NoIsotropy_H
+
+#include "IsotropyModel.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace IsotropyModels
+{
+
+/*---------------------------------------------------------------------------*\
+                         Class NoIsotropy Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class CloudType>
+class NoIsotropy
+:
+    public IsotropyModel<CloudType>
+{
+public:
+
+    //- Runtime type information
+    TypeName("none");
+
+    // Constructors
+
+        //- Construct from components
+        NoIsotropy(const dictionary& dict, CloudType& owner);
+
+        //- Construct copy
+        NoIsotropy(const NoIsotropy<CloudType>& cm);
+
+        //- Construct and return a clone
+        virtual autoPtr<IsotropyModel<CloudType> > clone() const
+        {
+            return autoPtr<IsotropyModel<CloudType> >
+            (
+                new NoIsotropy<CloudType>(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~NoIsotropy();
+
+
+    //- Member Functions
+
+        //- calculate velocities
+        virtual void calculate();
+
+        //- Return the model 'active' status
+        virtual bool active() const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace IsotropyModels
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "NoIsotropy.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/Stochastic/Stochastic.C b/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/Stochastic/Stochastic.C
new file mode 100644
index 0000000000000000000000000000000000000000..fcf022e5d21e7fe4b56a9c2b1801ed0fba802476
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/Stochastic/Stochastic.C
@@ -0,0 +1,257 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "Stochastic.H"
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::IsotropyModels::Stochastic<CloudType>::Stochastic
+(
+    const dictionary& dict,
+    CloudType& owner
+)
+:
+    IsotropyModel<CloudType>(dict, owner, typeName)
+{}
+
+
+template<class CloudType>
+Foam::IsotropyModels::Stochastic<CloudType>::Stochastic
+(
+    const Stochastic<CloudType>& cm
+)
+:
+    IsotropyModel<CloudType>(cm)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::IsotropyModels::Stochastic<CloudType>::~Stochastic()
+{}
+
+
+// * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::scalar Foam::IsotropyModels::Stochastic<CloudType>::sampleGauss()
+{
+    static bool isCached = true;
+    static scalar xCached;
+
+    if (isCached)
+    {
+        isCached = false;
+
+        return xCached;
+    }
+    else
+    {
+        cachedRandom& rndGen = this->owner().rndGen();
+
+        scalar f, m, x, y;
+
+        do
+        {
+            x = 2.0*rndGen.sample01<scalar>() - 1.0;
+            y = 2.0*rndGen.sample01<scalar>() - 1.0;
+            m = x*x + y*y;
+        } while (m >= 1.0 || m == 0.0);
+
+        f = sqrt(-2.0*log(m)/m);
+        xCached = x*f;
+        isCached = true;
+
+        return y*f;
+    }
+}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class CloudType>
+void Foam::IsotropyModels::Stochastic<CloudType>::calculate()
+{
+    const fvMesh& mesh = this->owner().mesh();
+    const scalar deltaT(this->owner().db().time().deltaTValue());
+    cachedRandom& rndGen = this->owner().rndGen();
+
+    const scalar oneBySqrtThree = sqrt(1.0/3.0);
+
+    const AveragingMethod<scalar>& volumeAverage =
+        mesh.lookupObject<AveragingMethod<scalar> >
+        (
+            this->owner().name() + ":volumeAverage"
+        );
+    const AveragingMethod<scalar>& radiusAverage =
+        mesh.lookupObject<AveragingMethod<scalar> >
+        (
+            this->owner().name() + ":radiusAverage"
+        );
+    const AveragingMethod<vector>& uAverage =
+        mesh.lookupObject<AveragingMethod<vector> >
+        (
+            this->owner().name() + ":uAverage"
+        );
+    const AveragingMethod<scalar>& uSqrAverage =
+        mesh.lookupObject<AveragingMethod<scalar> >
+        (
+            this->owner().name() + ":uSqrAverage"
+        );
+    const AveragingMethod<scalar>& frequencyAverage =
+        mesh.lookupObject<AveragingMethod<scalar> >
+        (
+            this->owner().name() + ":frequencyAverage"
+        );
+    const AveragingMethod<scalar>& massAverage =
+        mesh.lookupObject<AveragingMethod<scalar> >
+        (
+            this->owner().name() + ":massAverage"
+        );
+
+    // calculate time scales and pdf exponent
+    autoPtr<AveragingMethod<scalar> > exponentAveragePtr
+    (
+        AveragingMethod<scalar>::New
+        (
+            IOobject
+            (
+                this->owner().name() + ":exponentAverage",
+                this->owner().db().time().timeName(),
+                mesh
+            ),
+            this->owner().solution().dict(),
+            mesh
+        )
+    );
+    AveragingMethod<scalar>& exponentAverage = exponentAveragePtr();
+    exponentAverage =
+        exp
+        (
+          - deltaT
+           *this->timeScaleModel_->oneByTau
+            (
+                volumeAverage,
+                radiusAverage,
+                uSqrAverage,
+                frequencyAverage
+            )
+        )();
+
+    // random sampling
+    forAllIter(typename CloudType, this->owner(), iter)
+    {
+        typename CloudType::parcelType& p = iter();
+        const tetIndices tetIs(p.cell(), p.tetFace(), p.tetPt(), mesh);
+
+        const scalar x = exponentAverage.interpolate(p.position(), tetIs);
+
+        if(x < rndGen.sample01<scalar>())
+        {
+            const vector r(sampleGauss(), sampleGauss(), sampleGauss());
+
+            const vector u = uAverage.interpolate(p.position(), tetIs);
+            const scalar uRms =
+                sqrt(max(uSqrAverage.interpolate(p.position(), tetIs), 0.0));
+
+            p.U() = u + r*uRms*oneBySqrtThree;
+        }
+    }
+
+    // correction velocity averages
+    autoPtr<AveragingMethod<vector> > uTildeAveragePtr
+    (
+        AveragingMethod<vector>::New
+        (
+            IOobject
+            (
+                this->owner().name() + ":uTildeAverage",
+                this->owner().db().time().timeName(),
+                mesh
+            ),
+            this->owner().solution().dict(),
+            mesh
+        )
+    );
+    AveragingMethod<vector>& uTildeAverage = uTildeAveragePtr();
+    forAllIter(typename CloudType, this->owner(), iter)
+    {
+        typename CloudType::parcelType& p = iter();
+        const tetIndices tetIs(p.cell(), p.tetFace(), p.tetPt(), mesh);
+        uTildeAverage.add(p.position(), tetIs, p.nParticle()*p.mass()*p.U());
+    }
+    uTildeAverage.average(massAverage);
+
+    autoPtr<AveragingMethod<scalar> > uTildeSqrAveragePtr
+    (
+        AveragingMethod<scalar>::New
+        (
+            IOobject
+            (
+                this->owner().name() + ":uTildeSqrAverage",
+                this->owner().db().time().timeName(),
+                mesh
+            ),
+            this->owner().solution().dict(),
+            mesh
+        )
+    );
+    AveragingMethod<scalar>& uTildeSqrAverage = uTildeSqrAveragePtr();
+    forAllIter(typename CloudType, this->owner(), iter)
+    {
+        typename CloudType::parcelType& p = iter();
+        const tetIndices tetIs(p.cell(), p.tetFace(), p.tetPt(), mesh);
+        const vector uTilde = uTildeAverage.interpolate(p.position(), tetIs);
+        uTildeSqrAverage.add
+        (
+            p.position(),
+            tetIs,
+            p.nParticle()*p.mass()*magSqr(p.U() - uTilde)
+        );
+    }
+    uTildeSqrAverage.average(massAverage);
+
+    // conservation correction
+    forAllIter(typename CloudType, this->owner(), iter)
+    {
+        typename CloudType::parcelType& p = iter();
+        const tetIndices tetIs(p.cell(), p.tetFace(), p.tetPt(), mesh);
+
+        const vector u = uAverage.interpolate(p.position(), tetIs);
+        const scalar uRms =
+            sqrt(max(uSqrAverage.interpolate(p.position(), tetIs), 0.0));
+
+        const vector uTilde = uTildeAverage.interpolate(p.position(), tetIs);
+        const scalar uTildeRms =
+            sqrt(max(uTildeSqrAverage.interpolate(p.position(), tetIs), 0.0));
+
+        p.U() = u + (p.U() - uTilde)*uRms/max(uTildeRms, SMALL);
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/Stochastic/Stochastic.H b/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/Stochastic/Stochastic.H
new file mode 100644
index 0000000000000000000000000000000000000000..f1e06f64de2b9c51206427a07451460bf4ff95f7
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/Stochastic/Stochastic.H
@@ -0,0 +1,129 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::IsotropyModels::Stochastic
+
+Description
+    Stochastic return-to-isotropy model.
+
+    Particle velocities are modified by sampling a gaussian-plus-delta
+    distribution, which depends on a time-scale. This randomises some particle
+    velocities whilst leaving others unchanged. The lower the value of the
+    time-scale, the greater the proportion of particle velocities affected.
+
+    A correction step is performed at the end to ensure that the model
+    conserves both momentum and granular temperature.
+
+    Reference:
+    \verbatim
+        "Inclusion of collisional return-to-isotropy in the MP-PIC method"
+        P O'Rourke and D Snider
+        Chemical Engineering Science
+        Volume 80, Issue 0, Pages 39-54, December 2012
+    \endverbatim
+
+SourceFiles
+    Stochastic.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef Stochastic_H
+#define Stochastic_H
+
+#include "IsotropyModel.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace IsotropyModels
+{
+
+/*---------------------------------------------------------------------------*\
+                         Class Stochastic Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class CloudType>
+class Stochastic
+:
+    public IsotropyModel<CloudType>
+{
+private:
+
+    // Private Member Functions
+
+        //- Sample a gaussian distribution using the Box-Muller method
+        scalar sampleGauss();
+
+
+public:
+
+    //- Runtime type information
+    TypeName("stochastic");
+
+    // Constructors
+
+        //- Construct from components
+        Stochastic(const dictionary& dict, CloudType& owner);
+
+        //- Construct copy
+        Stochastic(const Stochastic<CloudType>& cm);
+
+        //- Construct and return a clone
+        virtual autoPtr<IsotropyModel<CloudType> > clone() const
+        {
+            return autoPtr<IsotropyModel<CloudType> >
+            (
+                new Stochastic<CloudType>(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~Stochastic();
+
+
+    //- Member Functions
+
+        //- Calculate velocities
+        virtual void calculate();
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace IsotropyModels
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "Stochastic.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/Explicit/Explicit.C b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/Explicit/Explicit.C
new file mode 100644
index 0000000000000000000000000000000000000000..f45df3034d11f817d6751d0914caa7031bcb6eaa
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/Explicit/Explicit.C
@@ -0,0 +1,191 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "Explicit.H"
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::PackingModels::Explicit<CloudType>::Explicit
+(
+    const dictionary& dict,
+    CloudType& owner
+)
+:
+    PackingModel<CloudType>(dict, owner, typeName),
+    stressAverage_(NULL),
+    correctionLimiting_
+    (
+        CorrectionLimitingMethod::New
+        (
+            this->coeffDict().subDict(CorrectionLimitingMethod::typeName)
+        )
+    )
+{}
+
+
+template<class CloudType>
+Foam::PackingModels::Explicit<CloudType>::Explicit
+(
+    const Explicit<CloudType>& cm
+)
+:
+    PackingModel<CloudType>(cm),
+    stressAverage_(cm.stressAverage_->clone()),
+    correctionLimiting_
+    (
+        cm.correctionLimiting_->clone()
+    )
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::PackingModels::Explicit<CloudType>::~Explicit()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class CloudType>
+void Foam::PackingModels::Explicit<CloudType>::cacheFields(const bool store)
+{
+    PackingModel<CloudType>::cacheFields(store);
+
+    if (store)
+    {
+        const fvMesh& mesh = this->owner().mesh();
+        const word& cloudName = this->owner().name();
+
+        const AveragingMethod<scalar>& volumeAverage =
+            mesh.lookupObject<AveragingMethod<scalar> >
+            (
+                cloudName + ":volumeAverage"
+            );
+        const AveragingMethod<scalar>& rhoAverage =
+            mesh.lookupObject<AveragingMethod<scalar> >
+            (
+                cloudName + ":rhoAverage"
+            );
+        const AveragingMethod<vector>& uAverage =
+            mesh.lookupObject<AveragingMethod<vector> >
+            (
+                cloudName + ":uAverage"
+            );
+        const AveragingMethod<scalar>& uSqrAverage =
+            mesh.lookupObject<AveragingMethod<scalar> >
+            (
+                cloudName + ":uSqrAverage"
+            );
+
+        volumeAverage_ = &volumeAverage;
+        uAverage_ = &uAverage;
+
+        stressAverage_.reset
+        (
+            AveragingMethod<scalar>::New
+            (
+                IOobject
+                (
+                    cloudName + ":stressAverage",
+                    this->owner().db().time().timeName(),
+                    mesh
+                ),
+                this->owner().solution().dict(),
+                mesh
+            ).ptr()
+        );
+
+        stressAverage_() =
+            this->particleStressModel_->tau
+            (
+                *volumeAverage_,
+                rhoAverage,
+                uSqrAverage
+            )();
+    }
+    else
+    {
+        volumeAverage_ = NULL;
+        uAverage_ = NULL;
+        stressAverage_.clear();
+    }
+}
+
+
+template<class CloudType>
+Foam::vector Foam::PackingModels::Explicit<CloudType>::velocityCorrection
+(
+    typename CloudType::parcelType& p,
+    const scalar deltaT
+) const
+{
+    const fvMesh& mesh = this->owner().mesh();
+    const tetIndices tetIs(p.cell(), p.tetFace(), p.tetPt(), mesh);
+
+    // interpolated quantities
+    const scalar alpha =
+        this->volumeAverage_->interpolate(p.position(), tetIs);
+    const vector alphaGrad =
+        this->volumeAverage_->interpolateGrad(p.position(), tetIs);
+    const vector uMean =
+        this->uAverage_->interpolate(p.position(), tetIs);
+
+    // stress gradient
+    const vector tauGrad =
+        stressAverage_->interpolateGrad(p.position(), tetIs);
+
+    // parcel relative velocity
+    const vector uRelative = p.U() - uMean;
+
+    // correction velocity
+    vector dU = vector::zero;
+
+    //// existing forces
+    //const scalar Re = p.Re(p.U(), p.d(), p.rhoc(), p.muc());
+    //const typename CloudType::forceType& forces = this->owner().forces();
+    //const forceSuSp F =
+    //    forces.calcCoupled(p, deltaT, p.mass(), Re, p.muc())
+    //  + forces.calcNonCoupled(p, deltaT, p.mass(), Re, p.muc());
+
+    // correction velocity
+    if((uRelative & alphaGrad) > 0)
+    {
+        dU = - deltaT*tauGrad/(p.rho()*alpha/* + deltaT*F.Sp()*/);
+    }
+
+    // apply the velocity limiters
+    return
+        correctionLimiting_->limitedVelocity
+        (
+            p.U(),
+            dU,
+            uMean
+        );
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/Explicit/Explicit.H b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/Explicit/Explicit.H
new file mode 100644
index 0000000000000000000000000000000000000000..15937ffb69aa73afd85c70a453f32d8e987081b9
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/Explicit/Explicit.H
@@ -0,0 +1,143 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::PackingModels::Explicit
+
+Description
+    Explicit model for applying an inter-particle stress to the particles.
+
+    The inter-particle stress is calculated using current particle locations.
+    This force is then applied only to the particles that are moving towards
+    regions of close pack. The resulting velocity change is limited using an
+    abtracted correction velocity limiter.
+
+    Reference:
+    \verbatim
+        "An Incompressible Three-Dimensional Multiphase Particle-in-Cell Model
+        for Dense Particle Flows"
+        D Snider
+        Journal of Computational Physics
+        Volume 170, Issue 2, Pages 523-549, July 2001
+    \endverbatim
+
+SourceFiles
+    Explicit.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef Explicit_H
+#define Explicit_H
+
+#include "PackingModel.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace PackingModels
+{
+
+/*---------------------------------------------------------------------------*\
+                         Class Explicit Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class CloudType>
+class Explicit
+:
+    public PackingModel<CloudType>
+{
+private:
+
+    //- Private data
+
+        //- Volume fraction average
+        const AveragingMethod<scalar>* volumeAverage_;
+
+        //- Velocity average
+        const AveragingMethod<vector>* uAverage_;
+
+        //- Stress average field
+        autoPtr<AveragingMethod<scalar> > stressAverage_;
+
+        //- Correction limiter
+        autoPtr<CorrectionLimitingMethod> correctionLimiting_;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("explicit");
+
+    // Constructors
+
+        //- Construct from components
+        Explicit(const dictionary& dict, CloudType& owner);
+
+        //- Construct copy
+        Explicit(const Explicit<CloudType>& cm);
+
+        //- Construct and return a clone
+        virtual autoPtr<PackingModel<CloudType> > clone() const
+        {
+            return autoPtr<PackingModel<CloudType> >
+            (
+                new Explicit<CloudType>(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~Explicit();
+
+
+    // Member Functions
+
+        //- Calculate the inter particles stresses
+        virtual void cacheFields(const bool store);
+
+        //- Calculate the velocity correction
+        virtual vector velocityCorrection
+        (
+            typename CloudType::parcelType& p,
+            const scalar deltaT
+        ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace PackingModels
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "Explicit.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/Implicit/Implicit.C b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/Implicit/Implicit.C
new file mode 100644
index 0000000000000000000000000000000000000000..d536dc047fdb9a3ebd33fbe0687d898c7ddc1d8e
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/Implicit/Implicit.C
@@ -0,0 +1,303 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "Implicit.H"
+#include "fixedValueFvsPatchField.H"
+#include "volPointInterpolation.H"                                              
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::PackingModels::Implicit<CloudType>::Implicit
+(
+    const dictionary& dict,
+    CloudType& owner
+)
+:
+    PackingModel<CloudType>(dict, owner, typeName),
+    alpha_
+    (
+        this->owner().name() + ":alpha",
+        this->owner().theta()
+    ),
+    phiCorrect_(NULL),
+    uCorrect_(NULL),
+    applyGravity_(this->coeffDict().lookup("applyGravity")),
+    alphaMin_(readScalar(this->coeffDict().lookup("alphaMin"))),
+    rhoMin_(readScalar(this->coeffDict().lookup("rhoMin")))
+{
+    alpha_.oldTime();
+}
+
+
+template<class CloudType>
+Foam::PackingModels::Implicit<CloudType>::Implicit
+(
+    const Implicit<CloudType>& cm
+)
+:
+    PackingModel<CloudType>(cm),
+    alpha_(cm.alpha_),
+    phiCorrect_(cm.phiCorrect_()),
+    uCorrect_(cm.uCorrect_()),
+    applyGravity_(cm.applyGravity_),
+    alphaMin_(cm.alphaMin_),
+    rhoMin_(cm.rhoMin_)
+{
+    alpha_.oldTime();
+}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::PackingModels::Implicit<CloudType>::~Implicit()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class CloudType>
+void Foam::PackingModels::Implicit<CloudType>::cacheFields(const bool store)
+{
+    PackingModel<CloudType>::cacheFields(store);
+
+    if (store)
+    { 
+        const fvMesh& mesh = this->owner().mesh();
+        const dimensionedScalar deltaT = this->owner().db().time().deltaT();
+        const word& cloudName = this->owner().name();
+
+        const dimensionedVector& g = this->owner().g();
+        const volScalarField& rhoc = this->owner().rho();
+
+        const AveragingMethod<scalar>& rhoAverage =
+            mesh.lookupObject<AveragingMethod<scalar> >
+            (
+                cloudName + ":rhoAverage"
+            );
+        const AveragingMethod<scalar>& uSqrAverage =
+            mesh.lookupObject<AveragingMethod<scalar> >
+            (
+                cloudName + ":uSqrAverage"
+            );
+
+
+        // Property fields
+        // ~~~~~~~~~~~~~~~
+
+        // volume fraction field
+        alpha_ = max(this->owner().theta(), alphaMin_);
+        alpha_.correctBoundaryConditions();
+
+        // average density
+        volScalarField rho
+        (
+            IOobject
+            (
+                cloudName + ":rho",
+                this->owner().db().time().timeName(),
+                mesh,
+                IOobject::NO_READ,
+                IOobject::NO_WRITE
+            ),
+            mesh,
+            dimensionedScalar("zero", dimDensity, 0),
+            zeroGradientFvPatchField<scalar>::typeName
+        );
+        rho.internalField() = max(rhoAverage.internalField(), rhoMin_);
+        rho.correctBoundaryConditions();
+
+        //Info << "       x: " << mesh.C().internalField().component(2) << endl;
+        //Info << "   alpha: " << alpha_.internalField() << endl;
+        //Info << "alphaOld: " << alpha_.oldTime().internalField() << endl;
+        //Info << "     rho: " << rho.internalField() << endl;
+        //Info << endl;
+
+        
+        // Stress field
+        // ~~~~~~~~~~~~
+
+        // stress derivative wrt volume fraction
+        volScalarField tauPrime
+        (
+            IOobject
+            (
+                cloudName + ":tauPrime",
+                this->owner().db().time().timeName(),
+                mesh,
+                IOobject::NO_READ,
+                IOobject::NO_WRITE
+            ),
+            mesh,
+            dimensionedScalar("zero", dimPressure, 0),
+            zeroGradientFvPatchField<scalar>::typeName
+        );
+
+        tauPrime.internalField() =
+            this->particleStressModel_->dTaudTheta
+            (
+                alpha_.internalField(),
+                rho.internalField(),
+                uSqrAverage.internalField()
+            )();
+
+        tauPrime.correctBoundaryConditions();
+
+
+        // Implicit solution for the volume fraction
+        // ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+
+        surfaceScalarField
+            tauPrimeByRhoAf
+            (
+                "tauPrimeByRhoAf",
+                fvc::interpolate(deltaT*tauPrime/rho)
+            );
+
+        fvScalarMatrix alphaEqn
+        (
+            fvm::ddt(alpha_)
+          - fvc::ddt(alpha_)
+          - fvm::laplacian(tauPrimeByRhoAf, alpha_)
+        );
+
+        if (applyGravity_)
+        {
+            surfaceScalarField
+                phiGByA
+                (
+                    "phiGByA",
+                    deltaT*(g & mesh.Sf())*fvc::interpolate(1.0 - rhoc/rho)
+                );
+
+            alphaEqn += fvm::div(phiGByA, alpha_);
+        }
+
+        alphaEqn.solve();
+
+        //// updated stress
+        //tauPrime.internalField() =
+        //    this->particleStressModel_->tauPrime
+        //    (
+        //        alpha_.internalField(),
+        //        rho.internalField(),
+        //        uSqrAverage.internalField()
+        //    )();
+        //tauPrime.correctBoundaryConditions();
+
+
+        // Generate correction fields
+        // ~~~~~~~~~~~~~~~~~
+
+        // correction volumetric flux
+        phiCorrect_ = tmp<surfaceScalarField>
+        (
+            new surfaceScalarField
+            (
+                cloudName + ":phiCorrect",
+                alphaEqn.flux()/fvc::interpolate(alpha_)
+            )
+        );
+
+        // correction velocity
+        uCorrect_ = tmp<volVectorField>
+        (
+            new volVectorField
+            (
+                cloudName + ":uCorrect",
+                fvc::reconstruct(phiCorrect_())
+            //  - deltaT*fvc::grad(tauPrime)/(rho*alpha_)
+            //  + (applyGravity_ ? deltaT*g*(1.0 - rhoc/rho) : 0.0)
+            )
+
+        );
+        uCorrect_->correctBoundaryConditions();
+
+        //Info << endl;
+        //Info << "     alpha: " << alpha_.internalField() << endl;
+        //Info << "phiCorrect: " << phiCorrect_->internalField() << endl;
+        //Info << "  uCorrect: " << uCorrect_->internalField() << endl;
+        //Info << endl;
+    }
+    else
+    {
+        alpha_.oldTime();
+        phiCorrect_.clear();
+        uCorrect_.clear();
+    }
+}
+
+
+template<class CloudType>
+Foam::vector Foam::PackingModels::Implicit<CloudType>::velocityCorrection
+(
+    typename CloudType::parcelType& p,
+    const scalar deltaT
+) const
+{
+    const fvMesh& mesh = this->owner().mesh();
+
+    // containing tetrahedron and parcel coordinates within
+    const label cellI = p.cell();
+    const label faceI = p.tetFace();
+    const tetIndices tetIs(cellI, faceI, p.tetPt(), mesh);
+    List<scalar> tetCoordinates(4);
+    tetIs.tet(mesh).barycentric(p.position(), tetCoordinates);
+
+    // cell velocity
+    const vector U = uCorrect_()[cellI];
+
+    // face geometry
+    vector nHat = mesh.faces()[faceI].normal(mesh.points());
+    const scalar nMag = mag(nHat);
+    nHat /= nMag;
+
+    // get face flux
+    scalar phi;
+    const label patchI = mesh.boundaryMesh().whichPatch(faceI);
+    if (patchI == -1)
+    {
+        phi = phiCorrect_()[faceI];
+    }
+    else
+    {
+        phi =
+            phiCorrect_().boundaryField()[patchI]
+            [
+                mesh.boundaryMesh()[patchI].whichFace(faceI)
+            ];
+    }
+
+    // interpolant equal to 1 at the cell centre and 0 at the face
+    const scalar t = tetCoordinates[0];
+
+    // the normal component of the velocity correction is interpolated linearly
+    // the tangential component is equal to that at the cell centre
+    return U + (1.0 - t)*nHat*(phi/nMag - (U & nHat));
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/Implicit/Implicit.H b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/Implicit/Implicit.H
new file mode 100644
index 0000000000000000000000000000000000000000..c3064d73f243093397cfcfedb868e3e78ac964fb
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/Implicit/Implicit.H
@@ -0,0 +1,140 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::PackingModels::Implicit
+
+Description
+    Implicit model for applying an inter-particle stress to the particles.
+
+    The time evolution of particulate volume fraction is solved for implicitly
+    on the eulerian mesh. The computed flux is then applied to the lagrangian
+    field. The gravity force can optionally be applied to the particles as part
+    of this model, using the keyword "applyGravity".
+
+SourceFiles
+    Implicit.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef Implicit_H
+#define Implicit_H
+
+#include "PackingModel.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace PackingModels
+{
+
+/*---------------------------------------------------------------------------*\
+                         Class Implicit Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class CloudType>
+class Implicit
+:
+    public PackingModel<CloudType>
+{
+private:
+
+    //- Private data
+            
+        //- Volume fraction field
+        volScalarField alpha_;
+
+        //- Correction flux
+        tmp<surfaceScalarField> phiCorrect_;
+
+        //- Correction cell-centred velocity
+        tmp<volVectorField> uCorrect_;
+
+        //- Flag to indicate whether gravity is applied
+        Switch applyGravity_;
+
+        //- Minimum stable volume fraction
+        scalar alphaMin_;
+
+        //- Minimum stable density
+        scalar rhoMin_;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("implicit");
+
+    // Constructors
+
+        //- Construct from components
+        Implicit(const dictionary& dict, CloudType& owner);
+
+        //- Construct copy
+        Implicit(const Implicit<CloudType>& cm);
+
+        //- Construct and return a clone
+        virtual autoPtr<PackingModel<CloudType> > clone() const
+        {
+            return autoPtr<PackingModel<CloudType> >
+            (
+                new Implicit<CloudType>(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~Implicit();
+
+
+    // Member Functions
+
+        //- Calculate the inter particles stresses
+        virtual void cacheFields(const bool store);
+
+        //- Calculate the velocity correction
+        virtual vector velocityCorrection
+        (
+            typename CloudType::parcelType& p,
+            const scalar deltaT
+        ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace PackingModels
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "Implicit.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/NoPacking/NoPacking.C b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/NoPacking/NoPacking.C
new file mode 100644
index 0000000000000000000000000000000000000000..92adbba777f9ab3ecaca7c038e30a8bb6d2ab309
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/NoPacking/NoPacking.C
@@ -0,0 +1,78 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "NoPacking.H"
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::PackingModels::NoPacking<CloudType>::NoPacking
+(
+    const dictionary& dict,
+    CloudType& owner
+)
+:
+    PackingModel<CloudType>(owner)
+{}
+
+
+template<class CloudType>
+Foam::PackingModels::NoPacking<CloudType>::NoPacking
+(
+    const NoPacking<CloudType>& cm
+)
+:
+    PackingModel<CloudType>(cm)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::PackingModels::NoPacking<CloudType>::~NoPacking()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::vector Foam::PackingModels::NoPacking<CloudType>::velocityCorrection
+(
+    typename CloudType::parcelType& p,
+    const scalar deltaT
+) const
+{
+    return vector::zero;
+}
+
+
+template<class CloudType>
+bool Foam::PackingModels::NoPacking<CloudType>::active() const
+{
+    return false;
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/NoPacking/NoPacking.H b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/NoPacking/NoPacking.H
new file mode 100644
index 0000000000000000000000000000000000000000..67bb37bf5d435ecb32531bea87e8fb2ec2f23a7d
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/NoPacking/NoPacking.H
@@ -0,0 +1,111 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::PackingModel::NoPacking
+
+Description
+
+SourceFiles
+    NoPacking.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef NoPacking_H
+#define NoPacking_H
+
+#include "PackingModel.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace PackingModels
+{
+
+/*---------------------------------------------------------------------------*\
+                         Class NoPacking Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class CloudType>
+class NoPacking
+:
+    public PackingModel<CloudType>
+{
+public:
+
+    //- Runtime type information
+    TypeName("none");
+
+    // Constructors
+
+        //- Construct from components
+        NoPacking(const dictionary& dict, CloudType& owner);
+
+        //- Construct copy
+        NoPacking(const NoPacking<CloudType>& cm);
+
+        //- Construct and return a clone
+        virtual autoPtr<PackingModel<CloudType> > clone() const
+        {
+            return autoPtr<PackingModel<CloudType> >
+            (
+                new NoPacking<CloudType>(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~NoPacking();
+
+
+    // Member Functions
+
+        //- Calculate the velocity correction
+        virtual vector velocityCorrection
+        (
+            typename CloudType::parcelType& p,
+            const scalar deltaT
+        ) const;
+
+        //- Return the model 'active' status
+        virtual bool active() const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace PackingModels
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "NoPacking.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/PackingModel/PackingModel.C b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/PackingModel/PackingModel.C
new file mode 100644
index 0000000000000000000000000000000000000000..fd29b22769163892399052cce310a870edab117b
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/PackingModel/PackingModel.C
@@ -0,0 +1,112 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "PackingModel.H"
+#include "AveragingMethod.H"
+#include "ParticleStressModel.H"
+#include "CorrectionLimitingMethod.H"
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::PackingModel<CloudType>::PackingModel(CloudType& owner)
+:
+    CloudSubModelBase<CloudType>(owner),
+    particleStressModel_(NULL)
+{}
+
+
+template<class CloudType>
+Foam::PackingModel<CloudType>::PackingModel
+(
+    const dictionary& dict,
+    CloudType& owner,
+    const word& type
+)
+:
+    CloudSubModelBase<CloudType>(owner, dict, typeName, type),
+    particleStressModel_
+    (
+        ParticleStressModel::New
+        (
+            this->coeffDict().subDict(ParticleStressModel::typeName)
+        )
+    )
+{}
+
+
+template<class CloudType>
+Foam::PackingModel<CloudType>::PackingModel(const PackingModel<CloudType>& cm)
+:
+    CloudSubModelBase<CloudType>(cm),
+    particleStressModel_(cm.particleStressModel_)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::PackingModel<CloudType>::~PackingModel()
+{}
+
+
+// * * * * * * * * * * * * * * * * Selector  * * * * * * * * * * * * * * * * //
+
+template<class CloudType>
+Foam::autoPtr<Foam::PackingModel<CloudType> >
+Foam::PackingModel<CloudType>::New
+(
+    const dictionary& dict,
+    CloudType& owner
+)
+{
+    word modelType(dict.lookup(typeName));
+
+    Info<< "Selecting packing model " << modelType << endl;
+
+    typename dictionaryConstructorTable::iterator cstrIter =
+        dictionaryConstructorTablePtr_->find(modelType);
+
+    if (cstrIter == dictionaryConstructorTablePtr_->end())
+    {
+        FatalErrorIn
+        (
+            "PackingModel<CloudType>::New"
+            "("
+                "const dictionary&, "
+                "CloudType&"
+            ")"
+        )   << "Unknown packing model type " << modelType
+            << ", constructor not in hash table" << nl << nl
+            << "    Valid packing model types are:" << nl
+            << dictionaryConstructorTablePtr_->sortedToc()
+            << exit(FatalError);
+    }
+
+    return autoPtr<PackingModel<CloudType> >(cstrIter()(dict, owner));
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/PackingModel/PackingModel.H b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/PackingModel/PackingModel.H
new file mode 100644
index 0000000000000000000000000000000000000000..6fcddbace16e4d5a71056ca5ec0e09584bbbb1a7
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/PackingModel/PackingModel.H
@@ -0,0 +1,178 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::PackingModel
+
+Description
+    Base class for packing models.
+
+SourceFiles
+    PackingModel.C
+    PackingModelNew.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef PackingModel_H
+#define PackingModel_H
+
+#include "IOdictionary.H"
+#include "autoPtr.H"
+#include "runTimeSelectionTables.H"
+#include "CloudSubModelBase.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+// Forward declaration of classes
+
+class ParticleStressModel;
+
+class CorrectionLimitingMethod;
+
+template <class Type>
+class AveragingMethod;
+
+/*---------------------------------------------------------------------------*\
+                         Class PackingModel Declaration
+\*---------------------------------------------------------------------------*/
+
+template<class CloudType>
+class PackingModel
+:
+    public CloudSubModelBase<CloudType>
+{
+protected:
+
+    //- Protected data
+
+        //- Particle stress model
+        autoPtr<ParticleStressModel> particleStressModel_;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("packingModel");
+
+    //- Declare runtime constructor selection table
+    declareRunTimeSelectionTable
+    (
+        autoPtr,
+        PackingModel,
+        dictionary,
+        (
+            const dictionary& dict,
+            CloudType& owner
+        ),
+        (dict, owner)
+    );
+
+
+    // Constructors
+
+        //- Construct null from owner
+        PackingModel(CloudType& owner);
+
+        //- Construct from components
+        PackingModel
+        (
+            const dictionary& dict,
+            CloudType& owner,
+            const word& type
+        );
+
+        //- Construct copy
+        PackingModel(const PackingModel<CloudType>& cm);
+
+        //- Construct and return a clone
+        virtual autoPtr<PackingModel<CloudType> > clone() const = 0;
+
+
+    //- Destructor
+    virtual ~PackingModel();
+
+
+    //- Selector
+    static autoPtr<PackingModel<CloudType> > New
+    (
+        const dictionary& dict,
+        CloudType& owner
+    );
+
+
+    // Member Functions
+
+        //- Calculate the velocity correction
+        virtual vector velocityCorrection
+        (
+            typename CloudType::parcelType& p,
+            const scalar deltaT
+        ) const = 0;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#define makePackingModel(CloudType)                                           \
+                                                                              \
+    typedef CloudType::MPPICCloudType MPPICCloudType;                         \
+    defineNamedTemplateTypeNameAndDebug                                       \
+    (                                                                         \
+        PackingModel<MPPICCloudType>,                                         \
+        0                                                                     \
+    );                                                                        \
+    defineTemplateRunTimeSelectionTable                                       \
+    (                                                                         \
+        PackingModel<MPPICCloudType>,                                         \
+        dictionary                                                            \
+    );
+
+
+#define makePackingModelType(SS, CloudType)                                   \
+                                                                              \
+    typedef CloudType::MPPICCloudType MPPICCloudType;                         \
+    defineNamedTemplateTypeNameAndDebug(SS<MPPICCloudType>, 0);               \
+                                                                              \
+    PackingModel<MPPICCloudType>::                                            \
+        adddictionaryConstructorToTable<SS<MPPICCloudType> >                  \
+            add##SS##CloudType##MPPICCloudType##ConstructorToTable_;
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+#   include "PackingModel.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/HarrisCrighton/HarrisCrighton.C b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/HarrisCrighton/HarrisCrighton.C
new file mode 100644
index 0000000000000000000000000000000000000000..ec7715d230c093c8248dd8abefa32ab207b36809
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/HarrisCrighton/HarrisCrighton.C
@@ -0,0 +1,135 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "HarrisCrighton.H"
+#include "addToRunTimeSelectionTable.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace ParticleStressModels
+{
+    defineTypeNameAndDebug(HarrisCrighton, 0);
+
+    addToRunTimeSelectionTable
+    (
+        ParticleStressModel,
+        HarrisCrighton,
+        dictionary
+    );
+}
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::ParticleStressModels::HarrisCrighton::HarrisCrighton
+(
+    const dictionary& dict
+)
+:
+    ParticleStressModel(dict),
+    pSolid_(readScalar(dict.lookup("pSolid"))),
+    beta_(readScalar(dict.lookup("beta"))),
+    eps_(readScalar(dict.lookup("eps")))
+{}
+
+
+Foam::ParticleStressModels::HarrisCrighton::HarrisCrighton
+(
+    const HarrisCrighton& hc
+)
+:
+    ParticleStressModel(hc),
+    pSolid_(hc.pSolid_),
+    beta_(hc.beta_),
+    eps_(hc.eps_)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+Foam::ParticleStressModels::HarrisCrighton::~HarrisCrighton()
+{}
+
+
+// * * * * * * * * * * * * * Privare Member Functions  * * * * * * * * * * * //
+
+Foam::tmp<Foam::Field<Foam::scalar> >
+Foam::ParticleStressModels::HarrisCrighton::denominator
+(
+    const Field<scalar>& alpha
+) const
+{
+    return
+        max
+        (
+            alphaPacked_ - alpha,
+            max(eps_*(1.0 - alpha), SMALL)
+        );
+}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+Foam::tmp<Foam::Field<Foam::scalar> >
+Foam::ParticleStressModels::HarrisCrighton::tau
+(
+    const Field<scalar>& alpha,
+    const Field<scalar>& rho,
+    const Field<scalar>& uSqr
+) const
+{
+    return
+    (
+        pSolid_
+      * pow(alpha, beta_)
+      / denominator(alpha)
+    );
+}
+
+
+Foam::tmp<Foam::Field<Foam::scalar> >
+Foam::ParticleStressModels::HarrisCrighton::dTaudTheta
+(
+    const Field<scalar>& alpha,
+    const Field<scalar>& rho,
+    const Field<scalar>& uSqr
+) const
+{
+    const Field<scalar> d(denominator(alpha));
+
+    return
+    (
+        pSolid_
+      * pow(alpha, beta_)
+      / d
+      * (beta_/alpha + 1.0/d)
+    );
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/HarrisCrighton/HarrisCrighton.H b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/HarrisCrighton/HarrisCrighton.H
new file mode 100644
index 0000000000000000000000000000000000000000..dd99caf88235827a46a7072ac79bf1e018d5ddea
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/HarrisCrighton/HarrisCrighton.H
@@ -0,0 +1,148 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::ParticleStressModels::HarrisCrighton
+
+Description
+    Inter-particle stress model of Harris and Crighton
+
+    The stress value takes the following form:
+    \f[
+        \frac{P_s \alpha^\beta}{ \mathrm{max} \left( \alpha_{pack} - \alpha ,
+        \epsilon ( 1 - \alpha ) \right) }
+    \f]
+    Here, \f$\alpha\f$ is the volume fraction of the dispersed phase, and the
+    other values are modelling constants. A small value \f$\epsilon\f$ is used
+    to limit the denominator to ensure numerical stability.
+
+    Reference:
+    \verbatim
+        "Solitons, solitary waves, and voidage disturbances in gas-fluidized
+        beds"
+        S Harris and D Crighton,
+        Journal of Fluid Mechanics
+        Volume 266, Pages 243-276, April 2006
+    \endverbatim
+
+SourceFiles
+    HarrisCrighton.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef HarrisCrighton_H
+#define HarrisCrighton_H
+
+#include "ParticleStressModel.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace ParticleStressModels
+{
+
+/*---------------------------------------------------------------------------*\
+                        Class HarrisCrighton Declaration
+\*---------------------------------------------------------------------------*/
+
+class HarrisCrighton
+:
+    public ParticleStressModel
+{
+    // Private data
+
+        //- Solid pressure coefficient
+        scalar pSolid_;
+
+        //- Exponent of the volume fraction
+        scalar beta_;
+
+        //- Smallest allowable difference from the packed volume fraction
+        scalar eps_;
+
+
+    // Private member functions
+
+        //- Return the limited denominator of the radial distribution function
+        tmp<Field<scalar> > denominator(const Field<scalar>& alpha) const;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("HarrisCrighton");
+
+
+    //- Constructors
+
+        //- Construct from components
+        HarrisCrighton(const dictionary& dict);
+
+        //- Construct copy
+        HarrisCrighton(const HarrisCrighton& hc);
+
+        //- Clone
+        virtual autoPtr<ParticleStressModel> clone() const
+        {
+            return autoPtr<ParticleStressModel>
+            (
+                new HarrisCrighton(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~HarrisCrighton();
+
+
+    //- Member Functions
+
+        //- Collision stress
+        tmp<Field<scalar> > tau
+        (
+            const Field<scalar>& alpha,
+            const Field<scalar>& rho,
+            const Field<scalar>& uRms
+        ) const;
+
+        //- Collision stress derivaive w.r.t. the volume fraction
+        tmp<Field<scalar> > dTaudTheta
+        (
+            const Field<scalar>& alpha,
+            const Field<scalar>& rho,
+            const Field<scalar>& uRms
+        ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace ParticleStressModels
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/Lun/Lun.C b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/Lun/Lun.C
new file mode 100644
index 0000000000000000000000000000000000000000..9962149fbda8ae18cb4939471ce0adbed4b4a36c
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/Lun/Lun.C
@@ -0,0 +1,122 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "Lun.H"
+#include "addToRunTimeSelectionTable.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace ParticleStressModels
+{
+    defineTypeNameAndDebug(Lun, 0);
+
+    addToRunTimeSelectionTable
+    (
+        ParticleStressModel,
+        Lun,
+        dictionary
+    );
+}
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::ParticleStressModels::Lun::Lun
+(
+    const dictionary& dict
+)
+:
+    ParticleStressModel(dict),
+    e_(readScalar(dict.lookup("e"))),
+    eps_(readScalar(dict.lookup("eps")))
+{}
+
+
+Foam::ParticleStressModels::Lun::Lun
+(
+    const Lun& ln
+)
+:
+    ParticleStressModel(ln),
+    e_(ln.e_),
+    eps_(ln.eps_)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+Foam::ParticleStressModels::Lun::~Lun()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+Foam::tmp<Foam::Field<Foam::scalar> >
+Foam::ParticleStressModels::Lun::tau
+(
+    const Field<scalar>& alpha,
+    const Field<scalar>& rho,
+    const Field<scalar>& uSqr
+) const
+{
+    tmp<Field<scalar> > g0
+    (
+        0.6
+      / max
+        (
+            1.0 - pow(alpha/alphaPacked_,1.0/3.0),
+            max(eps_*(1.0 - alpha), SMALL)
+        )
+    );
+
+    tmp<Field<scalar> > gT(uSqr/3.0);
+
+    return alpha*rho*(1.0 + alpha*(1.0 + e_)*g0)*gT;
+}
+
+
+Foam::tmp<Foam::Field<Foam::scalar> >
+Foam::ParticleStressModels::Lun::dTaudTheta
+(
+    const Field<scalar>& alpha,
+    const Field<scalar>& rho,
+    const Field<scalar>& uSqr
+) const
+{
+    notImplemented
+    (
+        "Foam::scalar Foam::ParticleStressModels::Lun::dTau_dTheta"
+        "(const Field<scalar>&, const Field<scalar>&, const Field<scalar>&) "
+        "const"
+    );
+
+    return tmp<Field<scalar> >(NULL);
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/Lun/Lun.H b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/Lun/Lun.H
new file mode 100644
index 0000000000000000000000000000000000000000..522acf3d25aea260e726e733c5f464cd83bf0875
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/Lun/Lun.H
@@ -0,0 +1,140 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::ParticleStressModels::Lun
+
+Description
+    Inter-particle stress model of Lun et al
+
+    The stress value takes the following form:
+    \f[
+        \left( \alpha \rho + \alpha^2 \rho (1 + e) \frac{3}{5}
+        \left( 1 - \left( \frac{\alpha}{\alpha_{pack}} \right)^\frac{1}{3}
+        \right) \right) \frac{1}{3} \sigma^2
+    \f]
+    Here, \f$\alpha\f$ is the volume fraction of the dispersed phase,
+    \f$\rho\f$ is the density of the dispersed phase, \f$e\f$ is a coefficient
+    of restitution, and \f$\sigma\f$ is the RMS velocity fluctuation.
+
+    Reference:
+    \verbatim
+        "Kinetic theories for granular flow: inelastic particles in Couette
+        flow and slightly inelastic particles in a general flowfield"
+        C Lun, S Savage, G Jeffrey, N Chepurniy
+        Journal of Fluid Mechanics
+        Volume 1, Page 223, April 2006
+    \endverbatim
+
+SourceFiles
+    Lun.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef Lun_H
+#define Lun_H
+
+#include "ParticleStressModel.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace ParticleStressModels
+{
+
+/*---------------------------------------------------------------------------*\
+                        Class Lun Declaration
+\*---------------------------------------------------------------------------*/
+
+class Lun
+:
+    public ParticleStressModel
+{
+    // Private data
+
+        //- Coefficient of restitution
+        scalar e_;
+
+        //- Smallest allowable difference from the packed volume fraction
+        scalar eps_;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("Lun");
+
+
+    //- Constructors
+
+        //- Construct from components
+        Lun(const dictionary& dict);
+
+        //- Construct copy
+        Lun(const Lun& hc);
+
+        //- Clone
+        virtual autoPtr<ParticleStressModel> clone() const
+        {
+            return autoPtr<ParticleStressModel>
+            (
+                new Lun(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~Lun();
+
+
+    //- Member Functions
+
+        //- Collision stress
+        tmp<Field<scalar> > tau
+        (
+            const Field<scalar>& alpha,
+            const Field<scalar>& rho,
+            const Field<scalar>& uRms
+        ) const;
+
+        //- Collision stress derivaive w.r.t. the volume fraction
+        tmp<Field<scalar> > dTaudTheta
+        (
+            const Field<scalar>& alpha,
+            const Field<scalar>& rho,
+            const Field<scalar>& uRms
+        ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace ParticleStressModels
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/ParticleStressModel/ParticleStressModel.C b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/ParticleStressModel/ParticleStressModel.C
new file mode 100644
index 0000000000000000000000000000000000000000..d95d42c4a1d3d8f7d32a30cb9da8d92b02ce84c9
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/ParticleStressModel/ParticleStressModel.C
@@ -0,0 +1,128 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "ParticleStressModel.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    defineTypeNameAndDebug(ParticleStressModel, 0);
+    defineRunTimeSelectionTable(ParticleStressModel, dictionary);
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::ParticleStressModel::ParticleStressModel
+(
+    const dictionary& dict
+)
+:
+    alphaPacked_(readScalar(dict.lookup("alphaPacked")))
+{
+}
+
+
+Foam::ParticleStressModel::ParticleStressModel
+(
+    const ParticleStressModel& cm
+)
+:
+    alphaPacked_(cm.alphaPacked_)
+{
+}
+
+
+// * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * * //
+
+Foam::autoPtr<Foam::ParticleStressModel> Foam::ParticleStressModel::New
+(
+    const dictionary& dict
+)
+{
+    word modelType(dict.lookup("type"));
+
+    Info<< "Selecting particle stress model " << modelType << endl;
+
+    dictionaryConstructorTable::iterator cstrIter =
+        dictionaryConstructorTablePtr_->find(modelType);
+
+    if (cstrIter == dictionaryConstructorTablePtr_->end())
+    {
+        FatalErrorIn
+        (
+            "ParticleStressModel::New"
+            "("
+                "const dictionary&"
+            ")"
+        )   << "Unknown particle stress model type " << modelType
+            << ", constructor not in hash table" << nl << nl
+            << "    Valid particle stress model types are:" << nl
+            << dictionaryConstructorTablePtr_->sortedToc()
+            << abort(FatalError);
+    }
+
+    return autoPtr<ParticleStressModel>(cstrIter()(dict));
+}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+Foam::ParticleStressModel::~ParticleStressModel()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+Foam::scalar Foam::ParticleStressModel::alphaPacked() const
+{
+    return alphaPacked_;
+}
+
+
+Foam::tmp<Foam::FieldField<Foam::Field, Foam::scalar> >
+Foam::ParticleStressModel::tau
+(
+    const FieldField<Field, scalar>& alpha,
+    const FieldField<Field, scalar>& rho,
+    const FieldField<Field, scalar>& uRms
+) const
+{
+    tmp<FieldField<Field, scalar> > value
+    (
+        new FieldField<Field, scalar>(alpha.size())
+    );
+
+    forAll(alpha, i)
+    {
+        value->set(i, tau(alpha[i], rho[i], uRms[i]));
+    }
+
+    return value;
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/ParticleStressModel/ParticleStressModel.H b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/ParticleStressModel/ParticleStressModel.H
new file mode 100644
index 0000000000000000000000000000000000000000..3338f3a94b6abeccfab370bbd825cedbfbb5665d
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/ParticleStressModel/ParticleStressModel.H
@@ -0,0 +1,147 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::ParticleStressModel
+
+Description
+    Base class for inter-particle stress models.
+
+SourceFiles
+    exponential.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef ParticleStressModel_H
+#define ParticleStressModel_H
+
+#include "fvCFD.H"
+#include "dictionary.H"
+#include "runTimeSelectionTables.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+/*---------------------------------------------------------------------------*\
+                        Class ParticleStressModel Declaration
+\*---------------------------------------------------------------------------*/
+
+class ParticleStressModel
+{
+private:
+
+    //- Private member functions
+
+        //- Disallow default bitwise assignment
+        void operator=(const ParticleStressModel&);
+
+
+protected:
+
+    // Protected data
+
+        //- Close pack volume fraction
+        scalar alphaPacked_;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("particleStressModel");
+
+    //- Declare runtime constructor selection table
+    declareRunTimeSelectionTable
+    (
+        autoPtr,
+        ParticleStressModel,
+        dictionary,
+        (const dictionary& dict),
+        (dict)
+    );
+
+
+    //- Constructors
+
+        //- Construct from components
+        ParticleStressModel(const dictionary& dict);
+
+        //- Construct a copy
+        ParticleStressModel(const ParticleStressModel& sm);
+
+        //- Construct and return a clone
+        virtual autoPtr<ParticleStressModel> clone() const = 0;
+
+
+    //- Selector
+    static autoPtr<ParticleStressModel> New
+    (
+        const dictionary& dict
+    );
+
+
+    //- Destructor
+    virtual ~ParticleStressModel();
+
+
+    //- Member Functions
+
+        //- Access max volume fraction
+        scalar alphaPacked() const;
+
+        //- Collision stress
+        virtual tmp<Field<scalar> > tau
+        (
+            const Field<scalar>& alpha,
+            const Field<scalar>& rho,
+            const Field<scalar>& uRms
+        ) const = 0;
+
+        //- Collision stress derivaive w.r.t. the volume fraction
+        virtual tmp<Field<scalar> > dTaudTheta
+        (
+            const Field<scalar>& alpha,
+            const Field<scalar>& rho,
+            const Field<scalar>& uRms
+        ) const = 0;
+
+        //- Collision stress using FieldFields
+        tmp<FieldField<Field, scalar> > tau
+        (
+            const FieldField<Field, scalar>& alpha,
+            const FieldField<Field, scalar>& rho,
+            const FieldField<Field, scalar>& uRms
+        ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/exponential/exponential.C b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/exponential/exponential.C
new file mode 100644
index 0000000000000000000000000000000000000000..2ac8811fca75269affaddb0119ede31da9312b24
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/exponential/exponential.C
@@ -0,0 +1,111 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "exponential.H"
+#include "addToRunTimeSelectionTable.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace ParticleStressModels
+{
+    defineTypeNameAndDebug(exponential, 0);
+
+    addToRunTimeSelectionTable
+    (
+        ParticleStressModel,
+        exponential,
+        dictionary
+    );
+}
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::ParticleStressModels::exponential::exponential
+(
+    const dictionary& dict
+)
+:
+    ParticleStressModel(dict),
+    preExp_(readScalar(dict.lookup("preExp"))),
+    expMax_(readScalar(dict.lookup("expMax"))),
+    g0_(readScalar(dict.lookup("g0")))
+{}
+
+
+Foam::ParticleStressModels::exponential::exponential
+(
+    const exponential& hc
+)
+:
+    ParticleStressModel(hc),
+    preExp_(hc.preExp_),
+    expMax_(hc.expMax_),
+    g0_(hc.g0_)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+Foam::ParticleStressModels::exponential::~exponential()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+Foam::tmp<Foam::Field<Foam::scalar> >
+Foam::ParticleStressModels::exponential::tau
+(
+    const Field<scalar>& alpha,
+    const Field<scalar>& rho,
+    const Field<scalar>& uSqr
+) const
+{
+    return dTaudTheta(alpha, rho, uSqr)/preExp_;
+}
+
+
+Foam::tmp<Foam::Field<Foam::scalar> >
+Foam::ParticleStressModels::exponential::dTaudTheta
+(
+    const Field<scalar>& alpha,
+    const Field<scalar>& rho,
+    const Field<scalar>& uSqr
+) const
+{
+    return
+        g0_
+       *min
+        (
+            exp(preExp_*(alpha - alphaPacked_)),
+            expMax_
+        );
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/exponential/exponential.H b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/exponential/exponential.H
new file mode 100644
index 0000000000000000000000000000000000000000..5d989622feb7cbb2d757e380092f10765e277f69
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/exponential/exponential.H
@@ -0,0 +1,125 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::ParticleStressModels::exponential
+
+Description
+    Exponential inter-particle stress model of the same form as used in
+    twoPhaseEulerFoam
+
+SourceFiles
+    exponential.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef exponential_H
+#define exponential_H
+
+#include "ParticleStressModel.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace ParticleStressModels
+{
+
+/*---------------------------------------------------------------------------*\
+                        Class exponential Declaration
+\*---------------------------------------------------------------------------*/
+
+class exponential
+:
+    public ParticleStressModel
+{
+    // Private data
+
+        //- Pre-exponential factor
+        scalar preExp_;
+
+        //- Maximum limit of the exponential
+        scalar expMax_;
+
+        //- Front coefficient
+        scalar g0_;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("exponential");
+
+
+    //- Constructors
+
+        //- Construct from components
+        exponential(const dictionary& dict);
+
+        //- Construct copy
+        exponential(const exponential& hc);
+
+        //- Clone
+        virtual autoPtr<ParticleStressModel> clone() const
+        {
+            return autoPtr<ParticleStressModel>
+            (
+                new exponential(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~exponential();
+
+
+    //- Member Functions
+
+        //- Collision stress
+        tmp<Field<scalar> > tau
+        (
+            const Field<scalar>& alpha,
+            const Field<scalar>& rho,
+            const Field<scalar>& uRms
+        ) const;
+
+        //- Collision stress derivaive w.r.t. the volume fraction
+        tmp<Field<scalar> > dTaudTheta
+        (
+            const Field<scalar>& alpha,
+            const Field<scalar>& rho,
+            const Field<scalar>& uRms
+        ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace ParticleStressModels
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/TimeScaleModel/TimeScaleModel.C b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/TimeScaleModel/TimeScaleModel.C
new file mode 100644
index 0000000000000000000000000000000000000000..bc4c7d5397ed40eec1727725d5f9bb83ea144c66
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/TimeScaleModel/TimeScaleModel.C
@@ -0,0 +1,100 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "TimeScaleModel.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    defineTypeNameAndDebug(TimeScaleModel, 0);
+    defineRunTimeSelectionTable(TimeScaleModel, dictionary);
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::TimeScaleModel::TimeScaleModel
+(
+    const dictionary& dict
+)
+:
+    alphaPacked_(readScalar(dict.lookup("alphaPacked"))),
+    e_(readScalar(dict.lookup("e")))
+{
+}
+
+
+Foam::TimeScaleModel::TimeScaleModel
+(
+    const TimeScaleModel& cm
+)
+:
+    alphaPacked_(cm.alphaPacked_),
+    e_(cm.e_)
+{
+}
+
+
+// * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * * //
+
+Foam::autoPtr<Foam::TimeScaleModel> Foam::TimeScaleModel::New
+(
+    const dictionary& dict
+)
+{
+    word modelType(dict.lookup("type"));
+
+    Info<< "Selecting time scale model " << modelType << endl;
+
+    dictionaryConstructorTable::iterator cstrIter =
+        dictionaryConstructorTablePtr_->find(modelType);
+
+    if (cstrIter == dictionaryConstructorTablePtr_->end())
+    {
+        FatalErrorIn
+        (
+            "TimeScaleModel::New"
+            "("
+                "const dictionary&"
+            ")"
+        )   << "Unknown time scale model type " << modelType
+            << ", constructor not in hash table" << nl << nl
+            << "    Valid time scale model types are:" << nl
+            << dictionaryConstructorTablePtr_->sortedToc()
+            << abort(FatalError);
+    }
+
+    return autoPtr<TimeScaleModel>(cstrIter()(dict));
+}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+Foam::TimeScaleModel::~TimeScaleModel()
+{}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/TimeScaleModel/TimeScaleModel.H b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/TimeScaleModel/TimeScaleModel.H
new file mode 100644
index 0000000000000000000000000000000000000000..6c7f6e938cb2084933c3d8bac2fff551b08a146f
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/TimeScaleModel/TimeScaleModel.H
@@ -0,0 +1,132 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::TimeScaleModel
+
+Description
+    Base class for time scale models.
+
+SourceFiles
+    TimeScaleModel.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef TimeScaleModel_H
+#define TimeScaleModel_H
+
+#include "fvCFD.H"
+#include "dictionary.H"
+#include "runTimeSelectionTables.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+/*---------------------------------------------------------------------------*\
+                        Class TimeScaleModel Declaration
+\*---------------------------------------------------------------------------*/
+
+class TimeScaleModel
+{
+private:
+
+    //- Private member functions
+
+        //- Disallow default bitwise assignment
+        void operator=(const TimeScaleModel&);
+
+
+protected:
+
+    // Protected data
+
+        //- Close pack volume fraction
+        scalar alphaPacked_;
+
+        //- Coefficient of restitution
+        scalar e_;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("timeScaleModel");
+
+    //- Declare runtime constructor selection table
+    declareRunTimeSelectionTable
+    (
+        autoPtr,
+        TimeScaleModel,
+        dictionary,
+        (const dictionary& dict),
+        (dict)
+    );
+
+
+    //- Constructors
+
+        //- Construct from components
+        TimeScaleModel(const dictionary& dict);
+
+        //- Construct a copy
+        TimeScaleModel(const TimeScaleModel& sm);
+
+        //- Construct and return a clone
+        virtual autoPtr<TimeScaleModel> clone() const = 0;
+
+
+    //- Selector
+    static autoPtr<TimeScaleModel> New
+    (
+        const dictionary& dict
+    );
+
+
+    //- Destructor
+    virtual ~TimeScaleModel();
+
+
+    //- Member Functions
+
+        //- Time scale
+        virtual tmp<FieldField<Field, scalar> > oneByTau
+        (
+            const FieldField<Field, scalar>& alpha,
+            const FieldField<Field, scalar>& r32,
+            const FieldField<Field, scalar>& uSqr,
+            const FieldField<Field, scalar>& f
+        ) const = 0;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/equilibrium/equilibrium.C b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/equilibrium/equilibrium.C
new file mode 100644
index 0000000000000000000000000000000000000000..c3d35c37fe4cf2830ca7dd13e28ca56697942ec7
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/equilibrium/equilibrium.C
@@ -0,0 +1,95 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "equilibrium.H"
+#include "addToRunTimeSelectionTable.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace TimeScaleModels
+{
+    defineTypeNameAndDebug(equilibrium, 0);
+
+    addToRunTimeSelectionTable
+    (
+        TimeScaleModel,
+        equilibrium,
+        dictionary
+    );
+}
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::TimeScaleModels::equilibrium::equilibrium
+(
+    const dictionary& dict
+)
+:
+    TimeScaleModel(dict)
+{}
+
+
+Foam::TimeScaleModels::equilibrium::equilibrium
+(
+    const equilibrium& hc
+)
+:
+    TimeScaleModel(hc)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+Foam::TimeScaleModels::equilibrium::~equilibrium()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+Foam::tmp<Foam::FieldField<Foam::Field, Foam::scalar> >
+Foam::TimeScaleModels::equilibrium::oneByTau
+(
+    const FieldField<Field, scalar>& alpha,
+    const FieldField<Field, scalar>& r32,
+    const FieldField<Field, scalar>& uSqr,
+    const FieldField<Field, scalar>& f
+) const
+{
+    static const scalar a =
+        16.0/sqrt(3.0*constant::mathematical::pi)
+       *0.25*(1.0 - e_*e_);
+
+    return 
+        a
+       *alpha*sqrt(max(uSqr, 0.0))/max(r32, SMALL)
+       *alphaPacked_/max(alphaPacked_ - alpha, SMALL);
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/equilibrium/equilibrium.H b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/equilibrium/equilibrium.H
new file mode 100644
index 0000000000000000000000000000000000000000..a8036d2711e3ede7a3b94035c2b875af28257e0d
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/equilibrium/equilibrium.H
@@ -0,0 +1,114 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::TimeScaleModels::equilibrium
+
+Description
+    Equlibrium model for the time scale over which properties of a dispersed
+    phase tend towards the mean value.
+
+    Reference:
+    \verbatim
+        "A model for collisional exchange in gas/liquid/solid fluidized beds"
+        P O'Rourke, P Zhao and D Snider
+        Chemical Engineering Science
+        Volume 64, Issue 8, Pages 1784-1797, April 2009
+    \endverbatim
+
+SourceFiles
+    equilibrium.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef equilibrium_H
+#define equilibrium_H
+
+#include "TimeScaleModel.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace TimeScaleModels
+{
+
+/*---------------------------------------------------------------------------*\
+                        Class equilibrium Declaration
+\*---------------------------------------------------------------------------*/
+
+class equilibrium
+:
+    public TimeScaleModel
+{
+public:
+
+    //- Runtime type information
+    TypeName("equilibrium");
+
+
+    //- Constructors
+
+        //- Construct from components
+        equilibrium(const dictionary& dict);
+
+        //- Construct a copy
+        equilibrium(const equilibrium& hc);
+
+        //- Construct and return a clone
+        virtual autoPtr<TimeScaleModel> clone() const
+        {
+            return autoPtr<TimeScaleModel>
+            (
+                new equilibrium(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~equilibrium();
+
+
+    //- Member Functions
+
+        //- Time scale
+        tmp<FieldField<Field, scalar> > oneByTau
+        (
+            const FieldField<Field, scalar>& alpha,
+            const FieldField<Field, scalar>& r32,
+            const FieldField<Field, scalar>& uSqr,
+            const FieldField<Field, scalar>& f
+        ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace TimeScaleModels
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/isotropic/isotropic.C b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/isotropic/isotropic.C
new file mode 100644
index 0000000000000000000000000000000000000000..bb8219e2aeb43963969b2a206b1ada55cf18bcd1
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/isotropic/isotropic.C
@@ -0,0 +1,92 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "isotropic.H"
+#include "addToRunTimeSelectionTable.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace TimeScaleModels
+{
+    defineTypeNameAndDebug(isotropic, 0);
+
+    addToRunTimeSelectionTable
+    (
+        TimeScaleModel,
+        isotropic,
+        dictionary
+    );
+}
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::TimeScaleModels::isotropic::isotropic
+(
+    const dictionary& dict
+)
+:
+    TimeScaleModel(dict)
+{}
+
+
+Foam::TimeScaleModels::isotropic::isotropic
+(
+    const isotropic& hc
+)
+:
+    TimeScaleModel(hc)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+Foam::TimeScaleModels::isotropic::~isotropic()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+Foam::tmp<Foam::FieldField<Foam::Field, Foam::scalar> >
+Foam::TimeScaleModels::isotropic::oneByTau
+(
+    const FieldField<Field, scalar>& alpha,
+    const FieldField<Field, scalar>& r32,
+    const FieldField<Field, scalar>& uSqr,
+    const FieldField<Field, scalar>& f
+) const
+{
+    static const scalar a =
+        8.0*sqrt(2.0)/(5.0*constant::mathematical::pi)
+       *0.25*(3.0 - e_)*(1.0 + e_);
+    
+    return a*f*alphaPacked_/max(alphaPacked_ - alpha, SMALL);
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/isotropic/isotropic.H b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/isotropic/isotropic.H
new file mode 100644
index 0000000000000000000000000000000000000000..dbca765160ef2d96770080d7594d1df2fc8fbe4b
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/isotropic/isotropic.H
@@ -0,0 +1,114 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::TimeScaleModels::isotropic
+
+Description
+    Model for the time scale over which the velocity field of a dispersed phase 
+    tends towards an isotropic distribution.
+
+    Reference:
+    \verbatim
+        "Inclusion of collisional return-to-isotropy in the MP-PIC method"
+        P O'Rourke and D Snider
+        Chemical Engineering Science
+        Volume 80, Issue 0, Pages 39-54, December 2012
+    \endverbatim
+
+SourceFiles
+    isotropic.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef isotropic_H
+#define isotropic_H
+
+#include "TimeScaleModel.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace TimeScaleModels
+{
+
+/*---------------------------------------------------------------------------*\
+                        Class isotropic Declaration
+\*---------------------------------------------------------------------------*/
+
+class isotropic
+:
+    public TimeScaleModel
+{
+public:
+
+    //- Runtime type information
+    TypeName("isotropic");
+
+
+    //- Constructors
+
+        //- Construct from components
+        isotropic(const dictionary& dict);
+
+        //- Construct a copy
+        isotropic(const isotropic& hc);
+
+        //- Construct and return a clone
+        virtual autoPtr<TimeScaleModel> clone() const
+        {
+            return autoPtr<TimeScaleModel>
+            (
+                new isotropic(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~isotropic();
+
+
+    //- Member Functions
+
+        //- Time scale
+        tmp<FieldField<Field, scalar> > oneByTau
+        (
+            const FieldField<Field, scalar>& alpha,
+            const FieldField<Field, scalar>& r32,
+            const FieldField<Field, scalar>& uSqr,
+            const FieldField<Field, scalar>& f
+        ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace TimeScaleModels
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/nonEquilibrium/nonEquilibrium.C b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/nonEquilibrium/nonEquilibrium.C
new file mode 100644
index 0000000000000000000000000000000000000000..d7462e813a53213e369fc8ea35213fdf83d3b6a1
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/nonEquilibrium/nonEquilibrium.C
@@ -0,0 +1,92 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "nonEquilibrium.H"
+#include "addToRunTimeSelectionTable.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace TimeScaleModels
+{
+    defineTypeNameAndDebug(nonEquilibrium, 0);
+
+    addToRunTimeSelectionTable
+    (
+        TimeScaleModel,
+        nonEquilibrium,
+        dictionary
+    );
+}
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::TimeScaleModels::nonEquilibrium::nonEquilibrium
+(
+    const dictionary& dict
+)
+:
+    TimeScaleModel(dict)
+{}
+
+
+Foam::TimeScaleModels::nonEquilibrium::nonEquilibrium
+(
+    const nonEquilibrium& hc
+)
+:
+    TimeScaleModel(hc)
+{}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+Foam::TimeScaleModels::nonEquilibrium::~nonEquilibrium()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+Foam::tmp<Foam::FieldField<Foam::Field, Foam::scalar> >
+Foam::TimeScaleModels::nonEquilibrium::oneByTau
+(
+    const FieldField<Field, scalar>& alpha,
+    const FieldField<Field, scalar>& r32,
+    const FieldField<Field, scalar>& uSqr,
+    const FieldField<Field, scalar>& f
+) const
+{
+    static const scalar a =
+        8.0*sqrt(2.0)/(3.0*constant::mathematical::pi)
+       *0.25*(1.0 - e_*e_);
+
+    return a*f*alphaPacked_/max(alphaPacked_ - alpha, SMALL);
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/nonEquilibrium/nonEquilibrium.H b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/nonEquilibrium/nonEquilibrium.H
new file mode 100644
index 0000000000000000000000000000000000000000..1c48f9bed13ea98279b135861f946359af2261f2
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/nonEquilibrium/nonEquilibrium.H
@@ -0,0 +1,116 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::TimeScaleModels::nonEquilibrium
+
+Description
+    Non-Equlibrium model for the time scale over which properties of a
+    dispersed phase tend towards the mean value.
+
+    Reference:
+    \verbatim
+        "An improved collision damping time for MP-PIC calculations of dense
+        particle flows with applications to polydisperse sedimenting beds and
+        colliding particle jets"
+        P O'Rourke and D Snider
+        Chemical Engineering Science
+        Volume 65, Issue 22, Pages 6014-6028, November 2010
+    \endverbatim
+
+SourceFiles
+    nonEquilibrium.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef nonEquilibrium_H
+#define nonEquilibrium_H
+
+#include "TimeScaleModel.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace TimeScaleModels
+{
+
+/*---------------------------------------------------------------------------*\
+                        Class nonEquilibrium Declaration
+\*---------------------------------------------------------------------------*/
+
+class nonEquilibrium
+:
+    public TimeScaleModel
+{
+public:
+
+    //- Runtime type information
+    TypeName("nonEquilibrium");
+
+
+    //- Constructors
+
+        //- Construct from components
+        nonEquilibrium(const dictionary& dict);
+
+        //- Construct a copy
+        nonEquilibrium(const nonEquilibrium& hc);
+
+        //- Construct and return a clone
+        virtual autoPtr<TimeScaleModel> clone() const
+        {
+            return autoPtr<TimeScaleModel>
+            (
+                new nonEquilibrium(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~nonEquilibrium();
+
+
+    //- Member Functions
+
+        //- Time scale
+        tmp<FieldField<Field, scalar> > oneByTau
+        (
+            const FieldField<Field, scalar>& alpha,
+            const FieldField<Field, scalar>& r32,
+            const FieldField<Field, scalar>& uSqr,
+            const FieldField<Field, scalar>& f
+        ) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace TimeScaleModels
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/spray/Make/options b/src/lagrangian/spray/Make/options
index 34a2babd735d8e8a6b2e69c447755c3660058595..d1deb55ae6888a2159a9890c1de37c7c058e8cd0 100644
--- a/src/lagrangian/spray/Make/options
+++ b/src/lagrangian/spray/Make/options
@@ -25,6 +25,7 @@ LIB_LIBS = \
     -lmeshTools \
     -llagrangian \
     -llagrangianIntermediate \
+    -llagrangianTurbulence \
     -ldistributionModels \
     -lspecie \
     -lfluidThermophysicalModels \
diff --git a/src/lagrangian/turbulence/Make/files b/src/lagrangian/turbulence/Make/files
new file mode 100644
index 0000000000000000000000000000000000000000..6aaf15b61ce083316bd6a8b10124a1ab2581d656
--- /dev/null
+++ b/src/lagrangian/turbulence/Make/files
@@ -0,0 +1,19 @@
+PARCELS=parcels
+DERIVEDPARCELS=$(PARCELS)/derived
+
+KINEMATICPARCEL=$(DERIVEDPARCELS)/basicKinematicParcel
+$(KINEMATICPARCEL)/makeBasicKinematicParcelSubmodels.C
+
+KINEMATICCOLLIDINGPARCEL=$(DERIVEDPARCELS)/basicKinematicCollidingParcel
+$(KINEMATICCOLLIDINGPARCEL)/makeBasicKinematicCollidingParcelSubmodels.C
+
+THERMOPARCEL=$(DERIVEDPARCELS)/basicThermoParcel
+$(THERMOPARCEL)/makeBasicThermoParcelSubmodels.C
+
+REACTINGPARCEL=$(DERIVEDPARCELS)/basicReactingParcel
+$(REACTINGPARCEL)/makeBasicReactingParcelSubmodels.C
+
+REACTINGMPPARCEL=$(DERIVEDPARCELS)/basicReactingMultiphaseParcel
+$(REACTINGMPPARCEL)/makeBasicReactingMultiphaseParcelSubmodels.C
+
+LIB = $(FOAM_LIBBIN)/liblagrangianTurbulence
diff --git a/src/lagrangian/turbulence/Make/options b/src/lagrangian/turbulence/Make/options
new file mode 100644
index 0000000000000000000000000000000000000000..be63379cf110038a13d16229bda2301381721869
--- /dev/null
+++ b/src/lagrangian/turbulence/Make/options
@@ -0,0 +1,50 @@
+EXE_INC = \
+    -I$(LIB_SRC)/finiteVolume/lnInclude \
+    -I$(LIB_SRC)/meshTools/lnInclude \
+    -I$(LIB_SRC)/lagrangian/basic/lnInclude \
+    -I$(LIB_SRC)/lagrangian/intermediate/lnInclude \
+    -I$(LIB_SRC)/lagrangian/distributionModels/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/specie/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/properties/liquidProperties/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/properties/liquidMixtureProperties/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/properties/solidProperties/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/properties/solidMixtureProperties/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/reactionThermo/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/SLGThermo/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/radiationModels/lnInclude \
+    -I$(LIB_SRC)/turbulenceModels \
+    -I$(LIB_SRC)/transportModels \
+    -I$(LIB_SRC)/regionModels/regionModel/lnInclude \
+    -I$(LIB_SRC)/regionModels/surfaceFilmModels/lnInclude \
+    -I$(LIB_SRC)/dynamicFvMesh/lnInclude \
+    -I$(LIB_SRC)/sampling/lnInclude
+
+LIB_LIBS = \
+    -lfiniteVolume \
+    -lmeshTools \
+    -llagrangian \
+    -llagrangianIntermediate \
+    -ldistributionModels \
+    -lspecie \
+    -lfluidThermophysicalModels \
+    -lliquidProperties \
+    -lliquidMixtureProperties \
+    -lsolidProperties \
+    -lsolidMixtureProperties \
+    -lreactionThermophysicalModels \
+    -lSLGThermo \
+    -lradiationModels \
+    -lincompressibleTurbulenceModel \
+    -lincompressibleRASModels \
+    -lincompressibleLESModels \
+    -lcompressibleTurbulenceModel \
+    -lcompressibleRASModels \
+    -lcompressibleLESModels \
+    -lLESdeltas \
+    -lincompressibleTransportModels \
+    -lregionModels \
+    -lsurfaceFilmModels \
+    -ldynamicFvMesh \
+    -lsampling
+
diff --git a/src/lagrangian/turbulence/parcels/derived/basicKinematicCollidingParcel/makeBasicKinematicCollidingParcelSubmodels.C b/src/lagrangian/turbulence/parcels/derived/basicKinematicCollidingParcel/makeBasicKinematicCollidingParcelSubmodels.C
new file mode 100644
index 0000000000000000000000000000000000000000..584dc186302bc572fe5e6a6046b7befa60ecafcf
--- /dev/null
+++ b/src/lagrangian/turbulence/parcels/derived/basicKinematicCollidingParcel/makeBasicKinematicCollidingParcelSubmodels.C
@@ -0,0 +1,57 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "basicKinematicCollidingCloud.H"
+
+#include "makeParcelCloudFunctionObjects.H"
+
+#include "GradientDispersionRAS.H"
+#include "StochasticDispersionRAS.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    typedef basicKinematicCollidingCloud::kinematicCloudType
+        kinematicCloudType_K;
+    defineNamedTemplateTypeNameAndDebug
+    (
+        DispersionRASModel<kinematicCloudType_K>,
+        0
+    );
+    makeDispersionModelType
+    (
+        GradientDispersionRAS,
+        basicKinematicCollidingCloud
+    );
+    makeDispersionModelType
+    (
+        StochasticDispersionRAS,
+        basicKinematicCollidingCloud
+    );
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/turbulence/parcels/derived/basicKinematicParcel/makeBasicKinematicParcelSubmodels.C b/src/lagrangian/turbulence/parcels/derived/basicKinematicParcel/makeBasicKinematicParcelSubmodels.C
new file mode 100644
index 0000000000000000000000000000000000000000..119de86cc63d13e0c56db4a2446068e7c8aacbb8
--- /dev/null
+++ b/src/lagrangian/turbulence/parcels/derived/basicKinematicParcel/makeBasicKinematicParcelSubmodels.C
@@ -0,0 +1,48 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "basicKinematicCloud.H"
+
+#include "makeParcelCloudFunctionObjects.H"
+
+#include "GradientDispersionRAS.H"
+#include "StochasticDispersionRAS.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    typedef basicKinematicCloud::kinematicCloudType kinematicCloudType_K;
+    defineNamedTemplateTypeNameAndDebug
+    (
+        DispersionRASModel<kinematicCloudType_K>,
+        0
+    );
+    makeDispersionModelType(GradientDispersionRAS, basicKinematicCloud);
+    makeDispersionModelType(StochasticDispersionRAS, basicKinematicCloud);
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/turbulence/parcels/derived/basicReactingMultiphaseParcel/makeBasicReactingMultiphaseParcelSubmodels.C b/src/lagrangian/turbulence/parcels/derived/basicReactingMultiphaseParcel/makeBasicReactingMultiphaseParcelSubmodels.C
new file mode 100644
index 0000000000000000000000000000000000000000..08720bbc764cf02b8fa933f0acd8d265eb3fb4f7
--- /dev/null
+++ b/src/lagrangian/turbulence/parcels/derived/basicReactingMultiphaseParcel/makeBasicReactingMultiphaseParcelSubmodels.C
@@ -0,0 +1,65 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "basicReactingMultiphaseCloud.H"
+
+#include "makeParcelCloudFunctionObjects.H"
+
+#include "GradientDispersionRAS.H"
+#include "StochasticDispersionRAS.H"
+
+#include "BrownianMotionForce.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    typedef basicReactingMultiphaseCloud::kinematicCloudType
+        kinematicCloudType_K;
+    defineNamedTemplateTypeNameAndDebug
+    (
+        DispersionRASModel<kinematicCloudType_K>,
+        0
+    );
+    makeDispersionModelType
+    (
+        GradientDispersionRAS,
+        basicReactingMultiphaseCloud
+    );
+    makeDispersionModelType
+    (
+        StochasticDispersionRAS,
+        basicReactingMultiphaseCloud
+    );
+
+    makeParticleForceModelType
+    (
+        BrownianMotionForce,
+        basicReactingMultiphaseCloud
+    );
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/turbulence/parcels/derived/basicReactingParcel/makeBasicReactingParcelSubmodels.C b/src/lagrangian/turbulence/parcels/derived/basicReactingParcel/makeBasicReactingParcelSubmodels.C
new file mode 100644
index 0000000000000000000000000000000000000000..da13ed2e1e7d9ffdc3c822a0aae7eee711f27b90
--- /dev/null
+++ b/src/lagrangian/turbulence/parcels/derived/basicReactingParcel/makeBasicReactingParcelSubmodels.C
@@ -0,0 +1,52 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "basicReactingCloud.H"
+
+#include "makeParcelCloudFunctionObjects.H"
+
+#include "GradientDispersionRAS.H"
+#include "StochasticDispersionRAS.H"
+
+#include "BrownianMotionForce.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    typedef basicReactingCloud::kinematicCloudType kinematicCloudType_K;
+    defineNamedTemplateTypeNameAndDebug
+    (
+        DispersionRASModel<kinematicCloudType_K>,
+        0
+    );
+    makeDispersionModelType(GradientDispersionRAS, basicReactingCloud);
+    makeDispersionModelType(StochasticDispersionRAS, basicReactingCloud);
+
+    makeParticleForceModelType(BrownianMotionForce, basicReactingCloud);
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/turbulence/parcels/derived/basicThermoParcel/makeBasicThermoParcelSubmodels.C b/src/lagrangian/turbulence/parcels/derived/basicThermoParcel/makeBasicThermoParcelSubmodels.C
new file mode 100644
index 0000000000000000000000000000000000000000..5c71da29f5dfd95481dad6a141a59e71546afbab
--- /dev/null
+++ b/src/lagrangian/turbulence/parcels/derived/basicThermoParcel/makeBasicThermoParcelSubmodels.C
@@ -0,0 +1,52 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "basicThermoCloud.H"
+
+#include "makeParcelCloudFunctionObjects.H"
+
+#include "GradientDispersionRAS.H"
+#include "StochasticDispersionRAS.H"
+
+#include "BrownianMotionForce.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    typedef basicThermoCloud::kinematicCloudType kinematicCloudType_K;
+    defineNamedTemplateTypeNameAndDebug
+    (
+        DispersionRASModel<kinematicCloudType_K>,
+        0
+    );
+    makeDispersionModelType(GradientDispersionRAS, basicThermoCloud);
+    makeDispersionModelType(StochasticDispersionRAS, basicThermoCloud);
+
+    makeParticleForceModelType(BrownianMotionForce, basicThermoCloud);
+}
+
+
+// ************************************************************************* //
diff --git a/src/lagrangian/turbulence/parcels/include/makeParcelDispersionModels.H b/src/lagrangian/turbulence/parcels/include/makeParcelDispersionModels.H
new file mode 100644
index 0000000000000000000000000000000000000000..be281ecb1e93f898357456f1cc68c70a0f2983fb
--- /dev/null
+++ b/src/lagrangian/turbulence/parcels/include/makeParcelDispersionModels.H
@@ -0,0 +1,53 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef makeParcelDispersionModels_h
+#define makeParcelDispersionModels_h
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#include "GradientDispersionRAS.H"
+#include "StochasticDispersionRAS.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#define makeParcelDispersionModels(CloudType)                                 \
+                                                                              \
+    typedef CloudType::kinematicCloudType kinematicCloudType;                 \
+    defineNamedTemplateTypeNameAndDebug                                       \
+    (                                                                         \
+        DispersionRASModel<kinematicCloudType>,                               \
+        0                                                                     \
+    );                                                                        \
+                                                                              \
+    makeDispersionModelType(GradientDispersionRAS, CloudType);                \
+    makeDispersionModelType(StochasticDispersionRAS, CloudType);              \
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/lagrangian/intermediate/submodels/Kinematic/DispersionModel/DispersionRASModel/DispersionRASModel.C b/src/lagrangian/turbulence/submodels/Kinematic/DispersionModel/DispersionRASModel/DispersionRASModel.C
similarity index 100%
rename from src/lagrangian/intermediate/submodels/Kinematic/DispersionModel/DispersionRASModel/DispersionRASModel.C
rename to src/lagrangian/turbulence/submodels/Kinematic/DispersionModel/DispersionRASModel/DispersionRASModel.C
diff --git a/src/lagrangian/intermediate/submodels/Kinematic/DispersionModel/DispersionRASModel/DispersionRASModel.H b/src/lagrangian/turbulence/submodels/Kinematic/DispersionModel/DispersionRASModel/DispersionRASModel.H
similarity index 100%
rename from src/lagrangian/intermediate/submodels/Kinematic/DispersionModel/DispersionRASModel/DispersionRASModel.H
rename to src/lagrangian/turbulence/submodels/Kinematic/DispersionModel/DispersionRASModel/DispersionRASModel.H
diff --git a/src/lagrangian/intermediate/submodels/Kinematic/DispersionModel/GradientDispersionRAS/GradientDispersionRAS.C b/src/lagrangian/turbulence/submodels/Kinematic/DispersionModel/GradientDispersionRAS/GradientDispersionRAS.C
similarity index 100%
rename from src/lagrangian/intermediate/submodels/Kinematic/DispersionModel/GradientDispersionRAS/GradientDispersionRAS.C
rename to src/lagrangian/turbulence/submodels/Kinematic/DispersionModel/GradientDispersionRAS/GradientDispersionRAS.C
diff --git a/src/lagrangian/intermediate/submodels/Kinematic/DispersionModel/GradientDispersionRAS/GradientDispersionRAS.H b/src/lagrangian/turbulence/submodels/Kinematic/DispersionModel/GradientDispersionRAS/GradientDispersionRAS.H
similarity index 100%
rename from src/lagrangian/intermediate/submodels/Kinematic/DispersionModel/GradientDispersionRAS/GradientDispersionRAS.H
rename to src/lagrangian/turbulence/submodels/Kinematic/DispersionModel/GradientDispersionRAS/GradientDispersionRAS.H
diff --git a/src/lagrangian/intermediate/submodels/Kinematic/DispersionModel/StochasticDispersionRAS/StochasticDispersionRAS.C b/src/lagrangian/turbulence/submodels/Kinematic/DispersionModel/StochasticDispersionRAS/StochasticDispersionRAS.C
similarity index 100%
rename from src/lagrangian/intermediate/submodels/Kinematic/DispersionModel/StochasticDispersionRAS/StochasticDispersionRAS.C
rename to src/lagrangian/turbulence/submodels/Kinematic/DispersionModel/StochasticDispersionRAS/StochasticDispersionRAS.C
diff --git a/src/lagrangian/intermediate/submodels/Kinematic/DispersionModel/StochasticDispersionRAS/StochasticDispersionRAS.H b/src/lagrangian/turbulence/submodels/Kinematic/DispersionModel/StochasticDispersionRAS/StochasticDispersionRAS.H
similarity index 100%
rename from src/lagrangian/intermediate/submodels/Kinematic/DispersionModel/StochasticDispersionRAS/StochasticDispersionRAS.H
rename to src/lagrangian/turbulence/submodels/Kinematic/DispersionModel/StochasticDispersionRAS/StochasticDispersionRAS.H
diff --git a/src/lagrangian/intermediate/submodels/Thermodynamic/ParticleForces/BrownianMotion/BrownianMotionForce.C b/src/lagrangian/turbulence/submodels/Thermodynamic/ParticleForces/BrownianMotion/BrownianMotionForce.C
similarity index 100%
rename from src/lagrangian/intermediate/submodels/Thermodynamic/ParticleForces/BrownianMotion/BrownianMotionForce.C
rename to src/lagrangian/turbulence/submodels/Thermodynamic/ParticleForces/BrownianMotion/BrownianMotionForce.C
diff --git a/src/lagrangian/intermediate/submodels/Thermodynamic/ParticleForces/BrownianMotion/BrownianMotionForce.H b/src/lagrangian/turbulence/submodels/Thermodynamic/ParticleForces/BrownianMotion/BrownianMotionForce.H
similarity index 100%
rename from src/lagrangian/intermediate/submodels/Thermodynamic/ParticleForces/BrownianMotion/BrownianMotionForce.H
rename to src/lagrangian/turbulence/submodels/Thermodynamic/ParticleForces/BrownianMotion/BrownianMotionForce.H
diff --git a/src/lagrangian/intermediate/submodels/Thermodynamic/ParticleForces/BrownianMotion/BrownianMotionForceI.H b/src/lagrangian/turbulence/submodels/Thermodynamic/ParticleForces/BrownianMotion/BrownianMotionForceI.H
similarity index 100%
rename from src/lagrangian/intermediate/submodels/Thermodynamic/ParticleForces/BrownianMotion/BrownianMotionForceI.H
rename to src/lagrangian/turbulence/submodels/Thermodynamic/ParticleForces/BrownianMotion/BrownianMotionForceI.H
diff --git a/src/mesh/autoMesh/autoHexMesh/autoHexMeshDriver/autoSnapDriver.H b/src/mesh/autoMesh/autoHexMesh/autoHexMeshDriver/autoSnapDriver.H
index 496f980a118c9a52ead5cc4bed659865532638f1..4e0f1d160b919b5cb3bdb2970eb0cc51bbc311ae 100644
--- a/src/mesh/autoMesh/autoHexMesh/autoHexMeshDriver/autoSnapDriver.H
+++ b/src/mesh/autoMesh/autoHexMesh/autoHexMeshDriver/autoSnapDriver.H
@@ -310,14 +310,13 @@ class autoSnapDriver
                 //- Find point on nearest feature edge (within searchDist).
                 //  Return point and feature
                 //  and store feature-edge to mesh-point and vice versa
-                pointIndexHit findNearFeatureEdge
+                Tuple2<label, pointIndexHit> findNearFeatureEdge
                 (
                     const indirectPrimitivePatch& pp,
                     const scalarField& snapDist,
                     const label pointI,
                     const point& estimatedPt,
 
-                    label& featI,
                     List<List<DynamicList<point> > >&,
                     List<List<DynamicList<pointConstraint> > >&,
                     vectorField&,
@@ -330,7 +329,7 @@ class autoSnapDriver
                 //  If another mesh point already referring to this feature
                 //  point and further away, reset that one to a near feature
                 //  edge (using findNearFeatureEdge above)
-                labelPair findNearFeaturePoint
+                Tuple2<label, pointIndexHit> findNearFeaturePoint
                 (
                     const indirectPrimitivePatch& pp,
                     const scalarField& snapDist,
diff --git a/src/mesh/autoMesh/autoHexMesh/autoHexMeshDriver/autoSnapDriverFeature.C b/src/mesh/autoMesh/autoHexMesh/autoHexMeshDriver/autoSnapDriverFeature.C
index 92ef64bf4577b030da9550bf30f6a65bf8351c25..03615a76bd233649ea8c2865659af7d718ffe826 100644
--- a/src/mesh/autoMesh/autoHexMesh/autoHexMeshDriver/autoSnapDriverFeature.C
+++ b/src/mesh/autoMesh/autoHexMesh/autoHexMeshDriver/autoSnapDriverFeature.C
@@ -170,7 +170,7 @@ void Foam::autoSnapDriver::smoothAndConstrain
 
                     if (isMasterEdge[meshEdges[edgeI]])
                     {
-                        label nbrPointI = edges[pEdges[i]].otherVertex(pointI);
+                        label nbrPointI = edges[edgeI].otherVertex(pointI);
                         if (constraints[nbrPointI].first() >= nConstraints)
                         {
                             dispSum[pointI] += disp[nbrPointI];
@@ -213,80 +213,6 @@ void Foam::autoSnapDriver::smoothAndConstrain
         }
     }
 }
-//XXXXXX
-//TODO: make proper parallel so coupled edges don't have double influence
-//void Foam::autoSnapDriver::smoothAndConstrain2
-//(
-//    const bool applyConstraints,
-//    const indirectPrimitivePatch& pp,
-//    const List<pointConstraint>& constraints,
-//    vectorField& disp
-//) const
-//{
-//    const fvMesh& mesh = meshRefiner_.mesh();
-//
-//    for (label avgIter = 0; avgIter < 20; avgIter++)
-//    {
-//        vectorField dispSum(pp.nPoints(), vector::zero);
-//        labelList dispCount(pp.nPoints(), 0);
-//
-//        const labelListList& pointEdges = pp.pointEdges();
-//        const edgeList& edges = pp.edges();
-//
-//        forAll(pointEdges, pointI)
-//        {
-//            const labelList& pEdges = pointEdges[pointI];
-//
-//            forAll(pEdges, i)
-//            {
-//                label nbrPointI = edges[pEdges[i]].otherVertex(pointI);
-//                dispSum[pointI] += disp[nbrPointI];
-//                dispCount[pointI]++;
-//            }
-//        }
-//
-//        syncTools::syncPointList
-//        (
-//            mesh,
-//            pp.meshPoints(),
-//            dispSum,
-//            plusEqOp<point>(),
-//            vector::zero,
-//            mapDistribute::transform()
-//        );
-//        syncTools::syncPointList
-//        (
-//            mesh,
-//            pp.meshPoints(),
-//            dispCount,
-//            plusEqOp<label>(),
-//            0,
-//            mapDistribute::transform()
-//        );
-//
-//        // Constraints
-//        forAll(constraints, pointI)
-//        {
-//            if (dispCount[pointI] > 0)// && constraints[pointI].first() <= 1)
-//            {
-//                // Mix my displacement with neighbours' displacement
-//                disp[pointI] =
-//                    0.5
-//                   *(disp[pointI] + dispSum[pointI]/dispCount[pointI]);
-//
-//                if (applyConstraints)
-//                {
-//                    disp[pointI] = transform
-//                    (
-//                        constraints[pointI].constraintTransformation(),
-//                        disp[pointI]
-//                    );
-//                }
-//            }
-//        }
-//    }
-//}
-//XXXXXX
 
 
 void Foam::autoSnapDriver::calcNearestFace
@@ -716,7 +642,7 @@ void Foam::autoSnapDriver::calcNearestFacePointProperties
         pNormals = List<point>(pNormals, visitOrder);
         pDisp = List<point>(pDisp, visitOrder);
         pFc = List<point>(pFc, visitOrder);
-        pFid = UIndirectList<label>(pFid, visitOrder);
+        pFid = UIndirectList<label>(pFid, visitOrder)();
     }
 }
 
@@ -1412,14 +1338,14 @@ Foam::labelPair Foam::autoSnapDriver::findDiagonalAttraction
 }
 
 
-Foam::pointIndexHit Foam::autoSnapDriver::findNearFeatureEdge
+Foam::Tuple2<Foam::label, Foam::pointIndexHit>
+Foam::autoSnapDriver::findNearFeatureEdge
 (
     const indirectPrimitivePatch& pp,
     const scalarField& snapDist,
     const label pointI,
     const point& estimatedPt,
 
-    label& featI,
     List<List<DynamicList<point> > >& edgeAttractors,
     List<List<DynamicList<pointConstraint> > >& edgeConstraints,
     vectorField& patchAttraction,
@@ -1430,16 +1356,18 @@ Foam::pointIndexHit Foam::autoSnapDriver::findNearFeatureEdge
 
     labelList nearEdgeFeat;
     List<pointIndexHit> nearEdgeInfo;
+    vectorField nearNormal;
     features.findNearestEdge
     (
         pointField(1, estimatedPt),
         scalarField(1, sqr(snapDist[pointI])),
         nearEdgeFeat,
-        nearEdgeInfo
+        nearEdgeInfo,
+        nearNormal
     );
 
     const pointIndexHit& nearInfo = nearEdgeInfo[0];
-    featI = nearEdgeFeat[0];
+    label featI = nearEdgeFeat[0];
 
     if (nearInfo.hit())
     {
@@ -1449,12 +1377,7 @@ Foam::pointIndexHit Foam::autoSnapDriver::findNearFeatureEdge
         (
             nearInfo.hitPoint()
         );
-        pointConstraint c;
-        const edge e = features[featI].edges()[nearInfo.index()];
-        vector eVec = e.vec(features[featI].points());
-        eVec /= mag(eVec)+VSMALL;
-        c.first() = 2;
-        c.second() = eVec;
+        pointConstraint c(Tuple2<label, vector>(2, nearNormal[0]));
         edgeConstraints[featI][nearInfo.index()].append(c);
 
         // Store for later use
@@ -1462,9 +1385,12 @@ Foam::pointIndexHit Foam::autoSnapDriver::findNearFeatureEdge
             nearInfo.hitPoint()-pp.localPoints()[pointI];
         patchConstraints[pointI] = c;
     }
-    return nearInfo;
+    return Tuple2<label, pointIndexHit>(featI, nearInfo);
 }
-Foam::labelPair Foam::autoSnapDriver::findNearFeaturePoint
+
+
+Foam::Tuple2<Foam::label, Foam::pointIndexHit>
+Foam::autoSnapDriver::findNearFeaturePoint
 (
     const indirectPrimitivePatch& pp,
     const scalarField& snapDist,
@@ -1485,26 +1411,23 @@ Foam::labelPair Foam::autoSnapDriver::findNearFeaturePoint
     const refinementFeatures& features = meshRefiner_.features();
 
     labelList nearFeat;
-    labelList nearIndex;
+    List<pointIndexHit> nearInfo;
     features.findNearestPoint
     (
         pointField(1, estimatedPt),
         scalarField(1, sqr(snapDist[pointI])),
         nearFeat,
-        nearIndex
+        nearInfo
     );
 
     label featI = nearFeat[0];
-    label featPointI = -1;
 
     if (featI != -1)
     {
         const point& pt = pp.localPoints()[pointI];
 
-        const treeDataPoint& shapes =
-            features.pointTrees()[featI].shapes();
-        featPointI = shapes.pointLabels()[nearIndex[0]];
-        const point& featPt = shapes.points()[featPointI];
+        label featPointI = nearInfo[0].index();
+        const point& featPt = nearInfo[0].hitPoint();
         scalar distSqr = magSqr(featPt-pt);
 
         // Check if already attracted
@@ -1535,7 +1458,6 @@ Foam::labelPair Foam::autoSnapDriver::findNearFeaturePoint
                 patchAttraction[oldPointI] = vector::zero;
                 patchConstraints[oldPointI] = pointConstraint();
 
-                label edgeFeatI;
                 findNearFeatureEdge
                 (
                     pp,
@@ -1543,7 +1465,6 @@ Foam::labelPair Foam::autoSnapDriver::findNearFeaturePoint
                     oldPointI,
                     pp.localPoints()[oldPointI],
 
-                    edgeFeatI,
                     edgeAttractors,
                     edgeConstraints,
                     patchAttraction,
@@ -1564,7 +1485,7 @@ Foam::labelPair Foam::autoSnapDriver::findNearFeaturePoint
         }
     }
 
-    return labelPair(featI, featPointI);
+    return Tuple2<label, pointIndexHit>(featI, nearInfo[0]);
 }
 
 
@@ -1635,7 +1556,6 @@ void Foam::autoSnapDriver::determineFeatures
             << featurePointStr().name() << endl;
     }
 
-    const refinementFeatures& features = meshRefiner_.features();
 
     forAll(pp.localPoints(), pointI)
     {
@@ -1662,6 +1582,7 @@ void Foam::autoSnapDriver::determineFeatures
             constraint
         );
 
+
         if
         (
             (constraint.first() > patchConstraints[pointI].first())
@@ -1694,15 +1615,14 @@ void Foam::autoSnapDriver::determineFeatures
                         // Behave like when having two surface normals so
                         // attract to nearest feature edge (with a guess for
                         // the multipatch point as starting point)
-                        label featI = -1;
-                        pointIndexHit nearInfo = findNearFeatureEdge
+                        Tuple2<label, pointIndexHit> nearInfo =
+                        findNearFeatureEdge
                         (
                             pp,
                             snapDist,
                             pointI,
                             multiPatchPt.hitPoint(),        //estimatedPt
 
-                            featI,
                             edgeAttractors,
                             edgeConstraints,
 
@@ -1710,14 +1630,15 @@ void Foam::autoSnapDriver::determineFeatures
                             patchConstraints
                         );
 
-                        if (nearInfo.hit())
+                        const pointIndexHit& info = nearInfo.second();
+                        if (info.hit())
                         {
                             // Dump
                             if (featureEdgeStr.valid())
                             {
                                 featureEdgeStr().write
                                 (
-                                    linePointRef(pt, nearInfo.hitPoint())
+                                    linePointRef(pt, info.hitPoint())
                                 );
                             }
                         }
@@ -1727,7 +1648,7 @@ void Foam::autoSnapDriver::determineFeatures
                             {
                                 missedEdgeStr().write
                                 (
-                                    linePointRef(pt, nearInfo.missPoint())
+                                    linePointRef(pt, info.missPoint())
                                 );
                             }
                         }
@@ -1744,15 +1665,13 @@ void Foam::autoSnapDriver::determineFeatures
                 // Determine nearest point on feature edge. Store constraint
                 // (calculated from feature edge, alternative would be to
                 //  use constraint calculated from both surfaceNormals)
-                label featI = -1;
-                pointIndexHit nearInfo = findNearFeatureEdge
+                Tuple2<label, pointIndexHit> nearInfo = findNearFeatureEdge
                 (
                     pp,
                     snapDist,
                     pointI,
                     estimatedPt,
 
-                    featI,
                     edgeAttractors,
                     edgeConstraints,
 
@@ -1760,14 +1679,15 @@ void Foam::autoSnapDriver::determineFeatures
                     patchConstraints
                 );
 
-                if (nearInfo.hit())
+                // Dump to obj
+                const pointIndexHit& info = nearInfo.second();
+                if (info.hit())
                 {
-                    // Dump
                     if (featureEdgeStr.valid())
                     {
                         featureEdgeStr().write
                         (
-                            linePointRef(pt, nearInfo.hitPoint())
+                            linePointRef(pt, info.hitPoint())
                         );
                     }
                 }
@@ -1777,7 +1697,7 @@ void Foam::autoSnapDriver::determineFeatures
                     {
                         missedEdgeStr().write
                         (
-                            linePointRef(pt, nearInfo.missPoint())
+                            linePointRef(pt, info.missPoint())
                         );
                     }
                 }
@@ -1787,7 +1707,7 @@ void Foam::autoSnapDriver::determineFeatures
                 // Mark point on the nearest feature point.
                 const point estimatedPt(pt + patchAttraction[pointI]);
 
-                labelPair nearInfo = findNearFeaturePoint
+                Tuple2<label, pointIndexHit> nearInfo = findNearFeaturePoint
                 (
                     pp,
                     snapDist,
@@ -1805,18 +1725,10 @@ void Foam::autoSnapDriver::determineFeatures
                     patchConstraints
                 );
 
-                if (nearInfo.first() != -1)
+                const pointIndexHit& info = nearInfo.second();
+                if (info.hit() && featurePointStr.valid())
                 {
-                    // Dump
-                    if (featurePointStr.valid())
-                    {
-                        const treeDataPoint& shapes =
-                            features.pointTrees()[nearInfo.first()].shapes();
-                        const point& featPt =
-                            shapes.points()[nearInfo.second()];
-
-                        featurePointStr().write(linePointRef(pt, featPt));
-                    }
+                    featurePointStr().write(linePointRef(pt, info.hitPoint()));
                 }
             }
         }
@@ -2027,22 +1939,20 @@ void Foam::autoSnapDriver::featureAttractionUsingFeatureEdges
 
             if (pointStatus[pointI] == 0)   // baffle edge
             {
-                label featI;
-                const pointIndexHit nearInfo = findNearFeatureEdge
+                Tuple2<label, pointIndexHit> nearInfo = findNearFeatureEdge
                 (
                     pp,
                     snapDist,
                     pointI,
                     pt,
 
-                    featI,
                     edgeAttractors,
                     edgeConstraints,
                     rawPatchAttraction,
                     rawPatchConstraints
                 );
 
-                if (!nearInfo.hit())
+                if (!nearInfo.second().hit())
                 {
                     //Pout<< "*** Failed to find close edge to point " << pt
                     //    << endl;
@@ -2051,23 +1961,21 @@ void Foam::autoSnapDriver::featureAttractionUsingFeatureEdges
             else if (pointStatus[pointI] == 1)   // baffle point
             {
                 labelList nearFeat;
-                labelList nearIndex;
+                List<pointIndexHit> nearInfo;
                 features.findNearestPoint
                 (
                     pointField(1, pt),
                     scalarField(1, sqr(snapDist[pointI])),
                     nearFeat,
-                    nearIndex
+                    nearInfo
                 );
 
                 label featI = nearFeat[0];
 
                 if (featI != -1)
                 {
-                    const treeDataPoint& shapes =
-                        features.pointTrees()[featI].shapes();
-                    label featPointI = shapes.pointLabels()[nearIndex[0]];
-                    const point& featPt = shapes.points()[featPointI];
+                    label featPointI = nearInfo[0].index();
+                    const point& featPt = nearInfo[0].hitPoint();
                     scalar distSqr = magSqr(featPt-pt);
 
                     // Check if already attracted
@@ -2097,7 +2005,6 @@ void Foam::autoSnapDriver::featureAttractionUsingFeatureEdges
                             // The current point is closer so wins. Reset
                             // the old point to attract to nearest edge
                             // instead.
-                            label edgeFeatI;
                             findNearFeatureEdge
                             (
                                 pp,
@@ -2105,7 +2012,6 @@ void Foam::autoSnapDriver::featureAttractionUsingFeatureEdges
                                 oldPointI,
                                 pp.localPoints()[oldPointI],
 
-                                edgeFeatI,
                                 edgeAttractors,
                                 edgeConstraints,
                                 rawPatchAttraction,
@@ -2128,7 +2034,6 @@ void Foam::autoSnapDriver::featureAttractionUsingFeatureEdges
                     //    << " for baffle-feature-point " << pt
                     //    << endl;
 
-                    label featI;
                     findNearFeatureEdge
                     (
                         pp,
@@ -2136,7 +2041,6 @@ void Foam::autoSnapDriver::featureAttractionUsingFeatureEdges
                         pointI,
                         pt,                     // starting point
 
-                        featI,
                         edgeAttractors,
                         edgeConstraints,
                         rawPatchAttraction,
diff --git a/src/mesh/autoMesh/autoHexMesh/externalDisplacementMeshMover/medialAxisMeshMover.C b/src/mesh/autoMesh/autoHexMesh/externalDisplacementMeshMover/medialAxisMeshMover.C
index b2a142accfada9399ab60ab44cbdf61371215fe2..0aa74be6c908020c934f2e7d1818fd59f3bb6332 100644
--- a/src/mesh/autoMesh/autoHexMesh/externalDisplacementMeshMover/medialAxisMeshMover.C
+++ b/src/mesh/autoMesh/autoHexMesh/externalDisplacementMeshMover/medialAxisMeshMover.C
@@ -51,7 +51,6 @@ namespace Foam
 
 // * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
 
-
 Foam::labelList Foam::medialAxisMeshMover::getFixedValueBCs
 (
     const pointVectorField& fld
@@ -118,63 +117,6 @@ Foam::medialAxisMeshMover::getPatch
 }
 
 
-void Foam::medialAxisMeshMover::calculateEdgeWeights
-(
-    const PackedBoolList& isMasterEdge,
-    const labelList& meshEdges,
-    const labelList& meshPoints,
-    const edgeList& edges,
-    scalarField& edgeWeights,
-    scalarField& invSumWeight
-) const
-{
-    const pointField& pts = mesh().points();
-
-    // Calculate edgeWeights and inverse sum of edge weights
-    edgeWeights.setSize(meshEdges.size());
-    invSumWeight.setSize(meshPoints.size());
-
-    forAll(edges, edgeI)
-    {
-        const edge& e = edges[edgeI];
-        scalar eMag = max
-        (
-            VSMALL,
-            mag
-            (
-                pts[meshPoints[e[1]]]
-              - pts[meshPoints[e[0]]]
-            )
-        );
-        edgeWeights[edgeI] = 1.0/eMag;
-    }
-
-    // Sum per point all edge weights
-    weightedSum
-    (
-        mesh(),
-        isMasterEdge,
-        meshEdges,
-        meshPoints,
-        edges,
-        edgeWeights,
-        scalarField(meshPoints.size(), 1.0),  // data
-        invSumWeight
-    );
-
-    // Inplace invert
-    forAll(invSumWeight, pointI)
-    {
-        scalar w = invSumWeight[pointI];
-
-        if (w > 0.0)
-        {
-            invSumWeight[pointI] = 1.0/w;
-        }
-    }
-}
-
-
 void Foam::medialAxisMeshMover::smoothPatchNormals
 (
     const label nSmoothDisp,
@@ -193,8 +135,9 @@ void Foam::medialAxisMeshMover::smoothPatchNormals
 
     scalarField edgeWeights(meshEdges.size());
     scalarField invSumWeight(meshPoints.size());
-    calculateEdgeWeights
+    meshRefinement::calculateEdgeWeights
     (
+        mesh(),
         isMasterEdge,
         meshEdges,
         meshPoints,
@@ -207,7 +150,7 @@ void Foam::medialAxisMeshMover::smoothPatchNormals
     vectorField average;
     for (label iter = 0; iter < nSmoothDisp; iter++)
     {
-        weightedSum
+        meshRefinement::weightedSum
         (
             mesh(),
             isMasterEdge,
@@ -284,8 +227,9 @@ void Foam::medialAxisMeshMover::smoothNormals
 
     scalarField edgeWeights(meshEdges.size());
     scalarField invSumWeight(meshPoints.size());
-    calculateEdgeWeights
+    meshRefinement::calculateEdgeWeights
     (
+        mesh(),
         isMasterEdge,
         meshEdges,
         meshPoints,
@@ -297,7 +241,7 @@ void Foam::medialAxisMeshMover::smoothNormals
     vectorField average;
     for (label iter = 0; iter < nSmoothDisp; iter++)
     {
-        weightedSum
+        meshRefinement::weightedSum
         (
             mesh(),
             isMasterEdge,
@@ -1059,8 +1003,9 @@ void Foam::medialAxisMeshMover::minSmoothField
 
     scalarField edgeWeights(meshEdges.size());
     scalarField invSumWeight(meshPoints.size());
-    calculateEdgeWeights
+    meshRefinement::calculateEdgeWeights
     (
+        mesh(),
         isMasterEdge,
         meshEdges,
         meshPoints,
@@ -1075,7 +1020,7 @@ void Foam::medialAxisMeshMover::minSmoothField
     for (label iter = 0; iter < nSmoothDisp; iter++)
     {
         scalarField average(pp.nPoints());
-        weightedSum
+        meshRefinement::weightedSum
         (
             mesh(),
             isMasterEdge,
@@ -1317,16 +1262,14 @@ void Foam::medialAxisMeshMover::findIsolatedRegions
 
                 forAll(f, fp)
                 {
-                    label patchPointI = f[fp];
-
                     if (extrudeStatus[f[fp]] != autoLayerDriver::NOEXTRUDE)
                     {
                         if (islandPoint[faceI] == -1)
                         {
                             // First point to extrude
-                            islandPoint[faceI] = patchPointI;
+                            islandPoint[faceI] = f[fp];
                         }
-                        else
+                        else if (islandPoint[faceI] != -2)
                         {
                             // Second or more point to extrude
                             islandPoint[faceI] = -2;
@@ -1336,12 +1279,11 @@ void Foam::medialAxisMeshMover::findIsolatedRegions
             }
 
             // islandPoint:
-            //  -1 : no point extruded
-            //  -2 : >= 2 points extruded
+            //  -1 : no point extruded on face
+            //  -2 : >= 2 points extruded on face
             //  >=0: label of point extruded
 
             // Check all surrounding faces that I am the islandPoint
-            boolList keptPoints(pp.nPoints(), false);
             forAll(pointFaces, patchPointI)
             {
                 if (extrudeStatus[patchPointI] != autoLayerDriver::NOEXTRUDE)
@@ -1422,6 +1364,7 @@ void Foam::medialAxisMeshMover::findIsolatedRegions
             }
         }
 
+
         if (returnReduce(nChanged, sumOp<label>()) == 0)
         {
             break;
@@ -1536,8 +1479,9 @@ void Foam::medialAxisMeshMover::smoothLambdaMuDisplacement
     // Calculate inverse sum of weights
     scalarField edgeWeights(meshEdges.size());
     scalarField invSumWeight(meshPoints.size());
-    calculateEdgeWeights
+    meshRefinement::calculateEdgeWeights
     (
+        mesh(),
         isMasterEdge,
         meshEdges,
         meshPoints,
@@ -1556,7 +1500,7 @@ void Foam::medialAxisMeshMover::smoothLambdaMuDisplacement
 
     for (label iter = 0; iter < nSmoothDisp; iter++)
     {
-        weightedSum
+        meshRefinement::weightedSum
         (
             mesh(),
             isMasterEdge,
@@ -1577,7 +1521,7 @@ void Foam::medialAxisMeshMover::smoothLambdaMuDisplacement
             }
         }
 
-        weightedSum
+        meshRefinement::weightedSum
         (
             mesh(),
             isMasterEdge,
@@ -1773,8 +1717,8 @@ void Foam::medialAxisMeshMover::calculateDisplacement
         mesh().globalData().nTotalPoints()
     );
 
-    //- Use strick extrusionIsland detection
-    const Switch detectExtrusionIsland = coeffDict.lookupOrDefault<label>
+    //- Use strict extrusionIsland detection
+    const Switch detectExtrusionIsland = coeffDict.lookupOrDefault<Switch>
     (
         "detectExtrusionIsland",
         true
diff --git a/src/mesh/autoMesh/autoHexMesh/externalDisplacementMeshMover/medialAxisMeshMover.H b/src/mesh/autoMesh/autoHexMesh/externalDisplacementMeshMover/medialAxisMeshMover.H
index b402ecba259731069ccc03c8f02b8be9a87f2fb4..1c270de274fd857db5df10b3e594e1acba7fe876 100644
--- a/src/mesh/autoMesh/autoHexMesh/externalDisplacementMeshMover/medialAxisMeshMover.H
+++ b/src/mesh/autoMesh/autoHexMesh/externalDisplacementMeshMover/medialAxisMeshMover.H
@@ -105,31 +105,6 @@ class medialAxisMeshMover
             const labelList&
         );
 
-        //- Weighted sum (over all subset of mesh points) by
-        //  summing contribution from (master) edges
-        template<class Type>
-        static void weightedSum
-        (
-            const polyMesh& mesh,
-            const PackedBoolList& isMasterEdge,
-            const labelList& meshEdges,
-            const labelList& meshPoints,
-            const edgeList& edges,
-            const scalarField& edgeWeights,
-            const Field<Type>& data,
-            Field<Type>& sum
-        );
-
-        void calculateEdgeWeights
-        (
-            const PackedBoolList& isMasterEdge,
-            const labelList& meshEdges,
-            const labelList& meshPoints,
-            const edgeList& edges,
-            scalarField& edgeWeights,
-            scalarField& invSumWeight
-        ) const;
-
 
         // Calculation of medial axis information
 
@@ -314,12 +289,6 @@ public:
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-#ifdef NoRepository
-#   include "medialAxisMeshMoverTemplates.C"
-#endif
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
 #endif
 
 // ************************************************************************* //
diff --git a/src/mesh/autoMesh/autoHexMesh/externalDisplacementMeshMover/medialAxisMeshMoverTemplates.C b/src/mesh/autoMesh/autoHexMesh/externalDisplacementMeshMover/medialAxisMeshMoverTemplates.C
deleted file mode 100644
index edd053f63ff270de357ec0ca2d7c253ab51fb038..0000000000000000000000000000000000000000
--- a/src/mesh/autoMesh/autoHexMesh/externalDisplacementMeshMover/medialAxisMeshMoverTemplates.C
+++ /dev/null
@@ -1,93 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
-     \\/     M anipulation  |
--------------------------------------------------------------------------------
-License
-    This file is part of OpenFOAM.
-
-    OpenFOAM is free software: you can redistribute it and/or modify it
-    under the terms of the GNU General Public License as published by
-    the Free Software Foundation, either version 3 of the License, or
-    (at your option) any later version.
-
-    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
-    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
-    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
-    for more details.
-
-    You should have received a copy of the GNU General Public License
-    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
-
-\*---------------------------------------------------------------------------*/
-
-#include "medialAxisMeshMover.H"
-#include "syncTools.H"
-
-// * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
-
-template<class Type>
-void Foam::medialAxisMeshMover::weightedSum
-(
-    const polyMesh& mesh,
-    const PackedBoolList& isMasterEdge,
-    const labelList& meshEdges,
-    const labelList& meshPoints,
-    const edgeList& edges,
-    const scalarField& edgeWeights,
-    const Field<Type>& pointData,
-    Field<Type>& sum
-)
-{
-    if
-    (
-        mesh.nEdges() != isMasterEdge.size()
-     || edges.size() != meshEdges.size()
-     || edges.size() != edgeWeights.size()
-     || meshPoints.size() != pointData.size()
-    )
-    {
-        FatalErrorIn("medialAxisMeshMover::weightedSum(..)")
-            << "Inconsistent sizes for edge or point data:"
-            << " meshEdges:" << meshEdges.size()
-            << " isMasterEdge:" << isMasterEdge.size()
-            << " edgeWeights:" << edgeWeights.size()
-            << " edges:" << edges.size()
-            << " pointData:" << pointData.size()
-            << " meshPoints:" << meshPoints.size()
-            << abort(FatalError);
-    }
-
-    sum.setSize(meshPoints.size());
-    sum = pTraits<Type>::zero;
-
-    forAll(edges, edgeI)
-    {
-        if (isMasterEdge.get(meshEdges[edgeI]) == 1)
-        {
-            const edge& e = edges[edgeI];
-
-            scalar eWeight = edgeWeights[edgeI];
-
-            label v0 = e[0];
-            label v1 = e[1];
-
-            sum[v0] += eWeight*pointData[v1];
-            sum[v1] += eWeight*pointData[v0];
-        }
-    }
-
-    syncTools::syncPointList
-    (
-        mesh,
-        meshPoints,
-        sum,
-        plusEqOp<Type>(),
-        pTraits<Type>::zero     // null value
-    );
-}
-
-
-// ************************************************************************* //
diff --git a/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinement.C b/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinement.C
index d93a5ca6d37b501bf12a060f503b2adda2c2d2e1..8d41eebd2540a279e5c3c95d5154624da9808725 100644
--- a/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinement.C
+++ b/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinement.C
@@ -1949,6 +1949,64 @@ void Foam::meshRefinement::checkCoupledFaceZones(const polyMesh& mesh)
 }
 
 
+void Foam::meshRefinement::calculateEdgeWeights
+(
+    const polyMesh& mesh,
+    const PackedBoolList& isMasterEdge,
+    const labelList& meshEdges,
+    const labelList& meshPoints,
+    const edgeList& edges,
+    scalarField& edgeWeights,
+    scalarField& invSumWeight
+)
+{
+    const pointField& pts = mesh.points();
+
+    // Calculate edgeWeights and inverse sum of edge weights
+    edgeWeights.setSize(meshEdges.size());
+    invSumWeight.setSize(meshPoints.size());
+
+    forAll(edges, edgeI)
+    {
+        const edge& e = edges[edgeI];
+        scalar eMag = max
+        (
+            VSMALL,
+            mag
+            (
+                pts[meshPoints[e[1]]]
+              - pts[meshPoints[e[0]]]
+            )
+        );
+        edgeWeights[edgeI] = 1.0/eMag;
+    }
+
+    // Sum per point all edge weights
+    weightedSum
+    (
+        mesh,
+        isMasterEdge,
+        meshEdges,
+        meshPoints,
+        edges,
+        edgeWeights,
+        scalarField(meshPoints.size(), 1.0),  // data
+        invSumWeight
+    );
+
+    // Inplace invert
+    forAll(invSumWeight, pointI)
+    {
+        scalar w = invSumWeight[pointI];
+
+        if (w > 0.0)
+        {
+            invSumWeight[pointI] = 1.0/w;
+        }
+    }
+}
+
+
 Foam::label Foam::meshRefinement::appendPatch
 (
     fvMesh& mesh,
@@ -2167,9 +2225,7 @@ Foam::label Foam::meshRefinement::addMeshedPatch
 //        );
 
         // Store
-        label sz = meshedPatches_.size();
-        meshedPatches_.setSize(sz+1);
-        meshedPatches_[sz] = name;
+        meshedPatches_.append(name);
 
         return patchI;
     }
diff --git a/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinement.H b/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinement.H
index f8d6258ba7c88deb888272674a583525308a19ba..57114bd7404e6358535df9f598a2de00f01fe84f 100644
--- a/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinement.H
+++ b/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinement.H
@@ -729,6 +729,33 @@ public:
             //- Helper function: check that face zones are synced
             static void checkCoupledFaceZones(const polyMesh&);
 
+            //- Helper: calculate edge weights (1/length)
+            static void calculateEdgeWeights
+            (
+                const polyMesh& mesh,
+                const PackedBoolList& isMasterEdge,
+                const labelList& meshEdges,
+                const labelList& meshPoints,
+                const edgeList& edges,
+                scalarField& edgeWeights,
+                scalarField& invSumWeight
+            );
+
+            //- Helper: weighted sum (over all subset of mesh points) by
+            //  summing contribution from (master) edges
+            template<class Type>
+            static void weightedSum
+            (
+                const polyMesh& mesh,
+                const PackedBoolList& isMasterEdge,
+                const labelList& meshEdges,
+                const labelList& meshPoints,
+                const edgeList& edges,
+                const scalarField& edgeWeights,
+                const Field<Type>& data,
+                Field<Type>& sum
+            );
+
 
         // Refinement
 
diff --git a/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinementRefine.C b/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinementRefine.C
index a7084e9fc6ef204bd6e1c658ea5bf617e7fe44cd..701c0dbbc077d1f58f5b92cff33265c6cefb711f 100644
--- a/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinementRefine.C
+++ b/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinementRefine.C
@@ -458,10 +458,18 @@ void Foam::meshRefinement::markFeatureCellLevel
     // Database to pass into trackedParticle::move
     trackedParticle::trackingData td(startPointCloud, maxFeatureLevel);
 
+
     // Track all particles to their end position (= starting feature point)
     // Note that the particle might have started on a different processor
     // so this will transfer across nicely until we can start tracking proper.
     scalar maxTrackLen = 2.0*mesh_.bounds().mag();
+
+    if (debug&meshRefinement::FEATURESEEDS)
+    {
+        Pout<< "Tracking " << startPointCloud.size()
+            << " particles over distance " << maxTrackLen
+            << " to find the starting cell" << endl;
+    }
     startPointCloud.move(td, maxTrackLen);
 
 
@@ -485,6 +493,11 @@ void Foam::meshRefinement::markFeatureCellLevel
         IDLList<trackedParticle>()
     );
 
+    if (debug&meshRefinement::FEATURESEEDS)
+    {
+        Pout<< "Constructing cloud for cell marking" << endl;
+    }
+
     forAllIter(Cloud<trackedParticle>, startPointCloud, iter)
     {
         const trackedParticle& startTp = iter();
@@ -532,11 +545,14 @@ void Foam::meshRefinement::markFeatureCellLevel
     while (true)
     {
         // Track all particles to their end position.
+        if (debug&meshRefinement::FEATURESEEDS)
+        {
+            Pout<< "Tracking " << cloud.size()
+                << " particles over distance " << maxTrackLen
+                << " to mark cells" << endl;
+        }
         cloud.move(td, maxTrackLen);
 
-
-        label nParticles = 0;
-
         // Make particle follow edge.
         forAllIter(Cloud<trackedParticle>, cloud, iter)
         {
@@ -578,15 +594,15 @@ void Foam::meshRefinement::markFeatureCellLevel
                 // seeded. Delete particle.
                 cloud.deleteParticle(tp);
             }
-            else
-            {
-                // Keep particle
-                nParticles++;
-            }
         }
 
-        reduce(nParticles, sumOp<label>());
-        if (nParticles == 0)
+
+        if (debug&meshRefinement::FEATURESEEDS)
+        {
+            Pout<< "Remaining particles " << cloud.size() << endl;
+        }
+
+        if (returnReduce(cloud.size(), sumOp<label>()) == 0)
         {
             break;
         }
diff --git a/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinementTemplates.C b/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinementTemplates.C
index 45fcee4d5d793861002b045680ef7763618c8005..528e812197f2da2fd1870d9a5b43bdb04be5042e 100644
--- a/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinementTemplates.C
+++ b/src/mesh/autoMesh/autoHexMesh/meshRefinement/meshRefinementTemplates.C
@@ -26,16 +26,12 @@ License
 #include "meshRefinement.H"
 #include "fvMesh.H"
 #include "globalIndex.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
+#include "syncTools.H"
 
 // * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
 
 // Add a T entry
-template<class T> void meshRefinement::updateList
+template<class T> void Foam::meshRefinement::updateList
 (
     const labelList& newToOld,
     const T& nullValue,
@@ -59,7 +55,7 @@ template<class T> void meshRefinement::updateList
 
 
 template<class T>
-T meshRefinement::gAverage
+T Foam::meshRefinement::gAverage
 (
     const polyMesh& mesh,
     const PackedBoolList& isMasterElem,
@@ -109,7 +105,7 @@ T meshRefinement::gAverage
 
 
 template<class T>
-T meshRefinement::gAverage
+T Foam::meshRefinement::gAverage
 (
     const polyMesh& mesh,
     const PackedBoolList& isMasterElem,
@@ -162,7 +158,7 @@ T meshRefinement::gAverage
 
 // Compare two lists over all boundary faces
 template<class T>
-void meshRefinement::testSyncBoundaryFaceList
+void Foam::meshRefinement::testSyncBoundaryFaceList
 (
     const scalar tol,
     const string& msg,
@@ -222,7 +218,7 @@ void meshRefinement::testSyncBoundaryFaceList
 // Print list sorted by coordinates. Used for comparing non-parallel v.s.
 // parallel operation
 template<class T>
-void meshRefinement::collectAndPrint
+void Foam::meshRefinement::collectAndPrint
 (
     const UList<point>& points,
     const UList<T>& data
@@ -268,7 +264,11 @@ void meshRefinement::collectAndPrint
 
 //template<class T, class Mesh>
 template<class GeoField>
-void meshRefinement::addPatchFields(fvMesh& mesh, const word& patchFieldType)
+void Foam::meshRefinement::addPatchFields
+(
+    fvMesh& mesh,
+    const word& patchFieldType
+)
 {
     HashTable<GeoField*> flds
     (
@@ -298,7 +298,11 @@ void meshRefinement::addPatchFields(fvMesh& mesh, const word& patchFieldType)
 
 // Reorder patch field
 template<class GeoField>
-void meshRefinement::reorderPatchFields(fvMesh& mesh, const labelList& oldToNew)
+void Foam::meshRefinement::reorderPatchFields
+(
+    fvMesh& mesh,
+    const labelList& oldToNew
+)
 {
     HashTable<GeoField*> flds
     (
@@ -316,7 +320,11 @@ void meshRefinement::reorderPatchFields(fvMesh& mesh, const labelList& oldToNew)
 
 
 template<class Enum>
-int meshRefinement::readFlags(const Enum& namedEnum, const wordList& words)
+int Foam::meshRefinement::readFlags
+(
+    const Enum& namedEnum,
+    const wordList& words
+)
 {
     int flags = 0;
 
@@ -330,8 +338,66 @@ int meshRefinement::readFlags(const Enum& namedEnum, const wordList& words)
 }
 
 
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+template<class Type>
+void Foam::meshRefinement::weightedSum
+(
+    const polyMesh& mesh,
+    const PackedBoolList& isMasterEdge,
+    const labelList& meshEdges,
+    const labelList& meshPoints,
+    const edgeList& edges,
+    const scalarField& edgeWeights,
+    const Field<Type>& pointData,
+    Field<Type>& sum
+)
+{
+    if
+    (
+        mesh.nEdges() != isMasterEdge.size()
+     || edges.size() != meshEdges.size()
+     || edges.size() != edgeWeights.size()
+     || meshPoints.size() != pointData.size()
+    )
+    {
+        FatalErrorIn("medialAxisMeshMover::weightedSum(..)")
+            << "Inconsistent sizes for edge or point data:"
+            << " meshEdges:" << meshEdges.size()
+            << " isMasterEdge:" << isMasterEdge.size()
+            << " edgeWeights:" << edgeWeights.size()
+            << " edges:" << edges.size()
+            << " pointData:" << pointData.size()
+            << " meshPoints:" << meshPoints.size()
+            << abort(FatalError);
+    }
+
+    sum.setSize(meshPoints.size());
+    sum = pTraits<Type>::zero;
+
+    forAll(edges, edgeI)
+    {
+        if (isMasterEdge.get(meshEdges[edgeI]) == 1)
+        {
+            const edge& e = edges[edgeI];
+
+            scalar eWeight = edgeWeights[edgeI];
+
+            label v0 = e[0];
+            label v1 = e[1];
+
+            sum[v0] += eWeight*pointData[v1];
+            sum[v1] += eWeight*pointData[v0];
+        }
+    }
+
+    syncTools::syncPointList
+    (
+        mesh,
+        meshPoints,
+        sum,
+        plusEqOp<Type>(),
+        pTraits<Type>::zero     // null value
+    );
+}
 
-} // End namespace Foam
 
 // ************************************************************************* //
diff --git a/src/mesh/autoMesh/autoHexMesh/refinementFeatures/refinementFeatures.C b/src/mesh/autoMesh/autoHexMesh/refinementFeatures/refinementFeatures.C
index a5109bc3c88a9c322211b1e80896d293a800d9b3..f2b730bc9d3ca5e00e832f375723c4a20cc37f40 100644
--- a/src/mesh/autoMesh/autoHexMesh/refinementFeatures/refinementFeatures.C
+++ b/src/mesh/autoMesh/autoHexMesh/refinementFeatures/refinementFeatures.C
@@ -26,6 +26,7 @@ License
 #include "refinementFeatures.H"
 #include "Time.H"
 #include "Tuple2.H"
+#include "DynamicField.H"
 
 // * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
 
@@ -41,7 +42,40 @@ void Foam::refinementFeatures::read
 
         fileName featFileName(dict.lookup("file"));
 
+
+        // Try reading extendedEdgeMesh first
+
+        IOobject extFeatObj
+        (
+            featFileName,                       // name
+            io.time().constant(),               // instance
+            "extendedFeatureEdgeMesh",          // local
+            io.time(),                          // registry
+            IOobject::MUST_READ,
+            IOobject::NO_WRITE,
+            false
+        );
+
+        const fileName fName(extFeatObj.filePath());
+
+        if (!fName.empty() && extendedEdgeMesh::canRead(fName))
+        {
+            autoPtr<extendedEdgeMesh> eMeshPtr = extendedEdgeMesh::New
+            (
+                fName
+            );
+
+            Info<< "Read extendedFeatureEdgeMesh " << extFeatObj.name()
+                << nl << incrIndent;
+            eMeshPtr().writeStats(Info);
+            Info<< decrIndent << endl;
+
+            set(featI, new extendedFeatureEdgeMesh(extFeatObj, eMeshPtr()));
+        }
+        else
         {
+            // Try reading edgeMesh
+
             IOobject featObj
             (
                 featFileName,                       // name
@@ -53,21 +87,106 @@ void Foam::refinementFeatures::read
                 false
             );
 
-            autoPtr<edgeMesh> eMeshPtr = edgeMesh::New(featObj.filePath());
+            const fileName fName(featObj.filePath());
 
-            set
-            (
-                featI,
-                new featureEdgeMesh
+            if (fName.empty())
+            {
+                FatalIOErrorIn
                 (
-                    featObj,
-                    eMeshPtr->points(),
-                    eMeshPtr->edges()
-                )
+                    "refinementFeatures::read"
+                    "(const objectRegistry&"
+                    ", const PtrList<dictionary>&)",
+                    dict
+                )   << "Could not open " << featObj.objectPath()
+                    << exit(FatalIOError);
+            }
+
+
+            // Read as edgeMesh
+            autoPtr<edgeMesh> eMeshPtr = edgeMesh::New(fName);
+            const edgeMesh& eMesh = eMeshPtr();
+
+            Info<< "Read edgeMesh " << featObj.name() << nl
+                << incrIndent;
+            eMesh.writeStats(Info);
+            Info<< decrIndent << endl;
+
+
+            // Analyse for feature points. These are all classified as mixed
+            // points for lack of anything better
+            const labelListList& pointEdges = eMesh.pointEdges();
+
+            labelList oldToNew(eMesh.points().size(), -1);
+            DynamicField<point> newPoints(eMesh.points().size());
+            forAll(pointEdges, pointI)
+            {
+                if (pointEdges[pointI].size() > 2)
+                {
+                    oldToNew[pointI] = newPoints.size();
+                    newPoints.append(eMesh.points()[pointI]);
+                }
+                //else if (pointEdges[pointI].size() == 2)
+                //MEJ: do something based on a feature angle?
+            }
+            label nFeatures = newPoints.size();
+            forAll(oldToNew, pointI)
+            {
+                if (oldToNew[pointI] == -1)
+                {
+                    oldToNew[pointI] = newPoints.size();
+                    newPoints.append(eMesh.points()[pointI]);
+                }
+            }
+
+
+            const edgeList& edges = eMesh.edges();
+            edgeList newEdges(edges.size());
+            forAll(edges, edgeI)
+            {
+                const edge& e = edges[edgeI];
+                newEdges[edgeI] = edge
+                (
+                    oldToNew[e[0]],
+                    oldToNew[e[1]]
+                );
+            }
+
+            // Construct an extendedEdgeMesh with
+            // - all points on more than 2 edges : mixed feature points
+            // - all edges : external edges
+
+            extendedEdgeMesh eeMesh
+            (
+                newPoints,          // pts
+                newEdges,           // eds
+                0,                  // (point) concaveStart
+                0,                  // (point) mixedStart
+                nFeatures,          // (point) nonFeatureStart
+                edges.size(),       // (edge) internalStart
+                edges.size(),       // (edge) flatStart
+                edges.size(),       // (edge) openStart
+                edges.size(),       // (edge) multipleStart
+                vectorField(0),     // normals
+                List<extendedEdgeMesh::sideVolumeType>(0),// normalVolumeTypes
+                vectorField(0),     // edgeDirections
+                labelListList(0),   // normalDirections
+                labelListList(0),   // edgeNormals
+                labelListList(0),   // featurePointNormals
+                labelListList(0),   // featurePointEdges
+                labelList(0)        // regionEdges
             );
+
+
+            Info<< "Constructed extendedFeatureEdgeMesh " << featObj.name()
+                << nl << incrIndent;
+            eeMesh.writeStats(Info);
+            Info<< decrIndent << endl;
+
+
+            set(featI, new extendedFeatureEdgeMesh(featObj, eeMesh));
         }
 
-        const featureEdgeMesh& eMesh = operator[](featI);
+        const edgeMesh& eMesh = operator[](featI);
 
         //eMesh.mergePoints(meshRefiner_.mergeDistance());
 
@@ -145,7 +264,7 @@ void Foam::refinementFeatures::buildTrees
     const labelList& featurePoints
 )
 {
-    const featureEdgeMesh& eMesh = operator[](featI);
+    const edgeMesh& eMesh = operator[](featI);
     const pointField& points = eMesh.points();
     const edgeList& edges = eMesh.edges();
 
@@ -277,7 +396,7 @@ Foam::refinementFeatures::refinementFeatures
     const PtrList<dictionary>& featDicts
 )
 :
-    PtrList<featureEdgeMesh>(featDicts.size()),
+    PtrList<extendedFeatureEdgeMesh>(featDicts.size()),
     distances_(featDicts.size()),
     levels_(featDicts.size()),
     edgeTrees_(featDicts.size()),
@@ -289,7 +408,7 @@ Foam::refinementFeatures::refinementFeatures
     // Search engines
     forAll(*this, i)
     {
-        const featureEdgeMesh& eMesh = operator[](i);
+        const extendedEdgeMesh& eMesh = operator[](i);
         const labelListList& pointEdges = eMesh.pointEdges();
 
         DynamicList<label> featurePoints;
@@ -303,81 +422,82 @@ Foam::refinementFeatures::refinementFeatures
 
         Info<< "Detected " << featurePoints.size()
             << " featurePoints out of " << pointEdges.size()
-            << " points on feature " << eMesh.name() << endl;
+            << " points on feature " << operator[](i).name()
+            << endl;
 
         buildTrees(i, featurePoints);
     }
 }
 
 
-Foam::refinementFeatures::refinementFeatures
-(
-    const objectRegistry& io,
-    const PtrList<dictionary>& featDicts,
-    const scalar minCos
-)
-:
-    PtrList<featureEdgeMesh>(featDicts.size()),
-    distances_(featDicts.size()),
-    levels_(featDicts.size()),
-    edgeTrees_(featDicts.size()),
-    pointTrees_(featDicts.size())
-{
-    // Read features
-    read(io, featDicts);
-
-    // Search engines
-    forAll(*this, i)
-    {
-        const featureEdgeMesh& eMesh = operator[](i);
-        const pointField& points = eMesh.points();
-        const edgeList& edges = eMesh.edges();
-        const labelListList& pointEdges = eMesh.pointEdges();
-
-        DynamicList<label> featurePoints;
-        forAll(pointEdges, pointI)
-        {
-            const labelList& pEdges = pointEdges[pointI];
-            if (pEdges.size() > 2)
-            {
-                featurePoints.append(pointI);
-            }
-            else if (pEdges.size() == 2)
-            {
-                // Check the angle
-                const edge& e0 = edges[pEdges[0]];
-                const edge& e1 = edges[pEdges[1]];
-
-                const point& p = points[pointI];
-                const point& p0 = points[e0.otherVertex(pointI)];
-                const point& p1 = points[e1.otherVertex(pointI)];
-
-                vector v0 = p-p0;
-                scalar v0Mag = mag(v0);
-
-                vector v1 = p1-p;
-                scalar v1Mag = mag(v1);
-
-                if
-                (
-                    v0Mag > SMALL
-                 && v1Mag > SMALL
-                 && ((v0/v0Mag & v1/v1Mag) < minCos)
-                )
-                {
-                    featurePoints.append(pointI);
-                }
-            }
-        }
-
-        Info<< "Detected " << featurePoints.size()
-            << " featurePoints out of " << points.size()
-            << " points on feature " << eMesh.name()
-            << " when using feature cos " << minCos << endl;
-
-        buildTrees(i, featurePoints);
-    }
-}
+//Foam::refinementFeatures::refinementFeatures
+//(
+//    const objectRegistry& io,
+//    const PtrList<dictionary>& featDicts,
+//    const scalar minCos
+//)
+//:
+//    PtrList<extendedFeatureEdgeMesh>(featDicts.size()),
+//    distances_(featDicts.size()),
+//    levels_(featDicts.size()),
+//    edgeTrees_(featDicts.size()),
+//    pointTrees_(featDicts.size())
+//{
+//    // Read features
+//    read(io, featDicts);
+//
+//    // Search engines
+//    forAll(*this, i)
+//    {
+//        const edgeMesh& eMesh = operator[](i);
+//        const pointField& points = eMesh.points();
+//        const edgeList& edges = eMesh.edges();
+//        const labelListList& pointEdges = eMesh.pointEdges();
+//
+//        DynamicList<label> featurePoints;
+//        forAll(pointEdges, pointI)
+//        {
+//            const labelList& pEdges = pointEdges[pointI];
+//            if (pEdges.size() > 2)
+//            {
+//                featurePoints.append(pointI);
+//            }
+//            else if (pEdges.size() == 2)
+//            {
+//                // Check the angle
+//                const edge& e0 = edges[pEdges[0]];
+//                const edge& e1 = edges[pEdges[1]];
+//
+//                const point& p = points[pointI];
+//                const point& p0 = points[e0.otherVertex(pointI)];
+//                const point& p1 = points[e1.otherVertex(pointI)];
+//
+//                vector v0 = p-p0;
+//                scalar v0Mag = mag(v0);
+//
+//                vector v1 = p1-p;
+//                scalar v1Mag = mag(v1);
+//
+//                if
+//                (
+//                    v0Mag > SMALL
+//                 && v1Mag > SMALL
+//                 && ((v0/v0Mag & v1/v1Mag) < minCos)
+//                )
+//                {
+//                    featurePoints.append(pointI);
+//                }
+//            }
+//        }
+//
+//        Info<< "Detected " << featurePoints.size()
+//            << " featurePoints out of " << points.size()
+//            << " points on feature " << i   //eMesh.name()
+//            << " when using feature cos " << minCos << endl;
+//
+//        buildTrees(i, featurePoints);
+//    }
+//}
 
 
 // * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
@@ -387,12 +507,16 @@ void Foam::refinementFeatures::findNearestEdge
     const pointField& samples,
     const scalarField& nearestDistSqr,
     labelList& nearFeature,
-    List<pointIndexHit>& nearInfo
+    List<pointIndexHit>& nearInfo,
+    vectorField& nearNormal
 ) const
 {
     nearFeature.setSize(samples.size());
     nearFeature = -1;
     nearInfo.setSize(samples.size());
+    nearInfo = pointIndexHit();
+    nearNormal.setSize(samples.size());
+    nearNormal = vector::zero;
 
     forAll(edgeTrees_, featI)
     {
@@ -418,8 +542,18 @@ void Foam::refinementFeatures::findNearestEdge
 
                 if (info.hit())
                 {
-                    nearInfo[sampleI] = info;
                     nearFeature[sampleI] = featI;
+                    nearInfo[sampleI] = pointIndexHit
+                    (
+                        info.hit(),
+                        info.hitPoint(),
+                        tree.shapes().edgeLabels()[info.index()]
+                    );
+
+                    const treeDataEdge& td = tree.shapes();
+                    const edge& e = td.edges()[nearInfo[sampleI].index()];
+                    nearNormal[sampleI] =  e.vec(td.points());
+                    nearNormal[sampleI] /= mag(nearNormal[sampleI])+VSMALL;
                 }
             }
         }
@@ -427,18 +561,71 @@ void Foam::refinementFeatures::findNearestEdge
 }
 
 
+//void Foam::refinementFeatures::findNearestPoint
+//(
+//    const pointField& samples,
+//    const scalarField& nearestDistSqr,
+//    labelList& nearFeature,
+//    labelList& nearIndex
+//) const
+//{
+//    nearFeature.setSize(samples.size());
+//    nearFeature = -1;
+//    nearIndex.setSize(samples.size());
+//    nearIndex = -1;
+//
+//    forAll(pointTrees_, featI)
+//    {
+//        const indexedOctree<treeDataPoint>& tree = pointTrees_[featI];
+//
+//        if (tree.shapes().pointLabels().size() > 0)
+//        {
+//            forAll(samples, sampleI)
+//            {
+//                const point& sample = samples[sampleI];
+//
+//                scalar distSqr;
+//                if (nearFeature[sampleI] != -1)
+//                {
+//                    label nearFeatI = nearFeature[sampleI];
+//                    const indexedOctree<treeDataPoint>& nearTree =
+//                        pointTrees_[nearFeatI];
+//                    label featPointI =
+//                        nearTree.shapes().pointLabels()[nearIndex[sampleI]];
+//                    const point& featPt =
+//                        operator[](nearFeatI).points()[featPointI];
+//                    distSqr = magSqr(featPt-sample);
+//                }
+//                else
+//                {
+//                    distSqr = nearestDistSqr[sampleI];
+//                }
+//
+//                pointIndexHit info = tree.findNearest(sample, distSqr);
+//
+//                if (info.hit())
+//                {
+//                    nearFeature[sampleI] = featI;
+//                    nearIndex[sampleI] = info.index();
+//                }
+//            }
+//        }
+//    }
+//}
+
+
 void Foam::refinementFeatures::findNearestPoint
 (
     const pointField& samples,
     const scalarField& nearestDistSqr,
     labelList& nearFeature,
-    labelList& nearIndex
+    List<pointIndexHit>& nearInfo
 ) const
 {
     nearFeature.setSize(samples.size());
     nearFeature = -1;
-    nearIndex.setSize(samples.size());
-    nearIndex = -1;
+    nearInfo.setSize(samples.size());
+    nearInfo = pointIndexHit();
 
     forAll(pointTrees_, featI)
     {
@@ -453,14 +640,7 @@ void Foam::refinementFeatures::findNearestPoint
                 scalar distSqr;
                 if (nearFeature[sampleI] != -1)
                 {
-                    label nearFeatI = nearFeature[sampleI];
-                    const indexedOctree<treeDataPoint>& nearTree =
-                        pointTrees_[nearFeatI];
-                    label featPointI =
-                        nearTree.shapes().pointLabels()[nearIndex[sampleI]];
-                    const point& featPt =
-                        operator[](nearFeatI).points()[featPointI];
-                    distSqr = magSqr(featPt-sample);
+                    distSqr = magSqr(nearInfo[sampleI].hitPoint()-sample);
                 }
                 else
                 {
@@ -472,7 +652,12 @@ void Foam::refinementFeatures::findNearestPoint
                 if (info.hit())
                 {
                     nearFeature[sampleI] = featI;
-                    nearIndex[sampleI] = info.index();
+                    nearInfo[sampleI] = pointIndexHit
+                    (
+                        info.hit(),
+                        info.hitPoint(),
+                        tree.shapes().pointLabels()[info.index()]
+                    );
                 }
             }
         }
diff --git a/src/mesh/autoMesh/autoHexMesh/refinementFeatures/refinementFeatures.H b/src/mesh/autoMesh/autoHexMesh/refinementFeatures/refinementFeatures.H
index aa2807bac16f008d5ba5ca31c1a1967338d01e1f..4cfaf20ffaf80de715f17f367e5ae3f1bcb5bf3c 100644
--- a/src/mesh/autoMesh/autoHexMesh/refinementFeatures/refinementFeatures.H
+++ b/src/mesh/autoMesh/autoHexMesh/refinementFeatures/refinementFeatures.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -35,7 +35,7 @@ SourceFiles
 #ifndef refinementFeatures_H
 #define refinementFeatures_H
 
-#include "featureEdgeMesh.H"
+#include "extendedFeatureEdgeMesh.H"
 #include "indexedOctree.H"
 #include "treeDataEdge.H"
 #include "treeDataPoint.H"
@@ -51,7 +51,7 @@ namespace Foam
 
 class refinementFeatures
 :
-    public PtrList<featureEdgeMesh>
+    public PtrList<extendedFeatureEdgeMesh>
 {
 private:
 
@@ -86,6 +86,20 @@ private:
             labelList& maxLevel
         ) const;
 
+
+protected:
+
+        const PtrList<indexedOctree<treeDataEdge> >& edgeTrees() const
+        {
+            return edgeTrees_;
+        }
+
+        const PtrList<indexedOctree<treeDataPoint> >& pointTrees() const
+        {
+            return pointTrees_;
+        }
+
+
 public:
 
     // Constructors
@@ -97,15 +111,6 @@ public:
             const PtrList<dictionary>& featDicts
         );
 
-        //- Construct from description and do geometric analysis to determine
-        //  feature points
-        refinementFeatures
-        (
-            const objectRegistry& io,
-            const PtrList<dictionary>& featDicts,
-            const scalar minCos
-        );
-
 
     // Member Functions
 
@@ -123,42 +128,38 @@ public:
                 return distances_;
             }
 
-            const PtrList<indexedOctree<treeDataEdge> >& edgeTrees() const
-            {
-                return edgeTrees_;
-            }
-
-            const PtrList<indexedOctree<treeDataPoint> >& pointTrees() const
-            {
-                return pointTrees_;
-            }
-
 
         // Query
 
             //- Highest distance of all features
             scalar maxDistance() const;
 
-            //- Find nearest point on nearest feature edge
+            //- Find nearest point on nearest feature edge. Sets
+            //  - nearFeature: index of feature mesh
+            //  - nearInfo   : location on feature edge and edge index
+            //                 (note: not feature edge index but index into
+            //                  edges() directly)
+            //  - nearNormal : local feature edge normal
             void findNearestEdge
             (
                 const pointField& samples,
                 const scalarField& nearestDistSqr,
                 labelList& nearFeature,
-                List<pointIndexHit>& nearInfo
+                List<pointIndexHit>& nearInfo,
+                vectorField& nearNormal
             ) const;
 
-            //- Find nearest feature point. Is an index into feature points
-            //  which itself is an index into the edgeMesh points.
-            //  So the point index is
-            //      pointTrees()[nearFeature].shapes().pointLabels()[nearIndex]
-            //  Wip.
+            //- Find nearest feature point. Sets
+            //  - nearFeature: index of feature mesh
+            //  - nearInfo   : location on feature point and point index.
+            //                 (note: not index into shapes().pointLabels() but
+            //                  index into points() directly)
             void findNearestPoint
             (
                 const pointField& samples,
                 const scalarField& nearestDistSqr,
                 labelList& nearFeature,
-                labelList& nearIndex
+                List<pointIndexHit>& nearInfo
             ) const;
 
             //- Find shell level higher than ptLevel
diff --git a/src/postProcessing/functionObjects/field/fieldValues/faceSource/faceSourceTemplates.C b/src/postProcessing/functionObjects/field/fieldValues/faceSource/faceSourceTemplates.C
index be7fb428e6721b8f6be140decae702995972ceef..76b50be88f1f2db7fb6394c99ec4438b76562820 100644
--- a/src/postProcessing/functionObjects/field/fieldValues/faceSource/faceSourceTemplates.C
+++ b/src/postProcessing/functionObjects/field/fieldValues/faceSource/faceSourceTemplates.C
@@ -314,19 +314,22 @@ bool Foam::fieldValues::faceSource::writeValues(const word& fieldName)
                 combineMeshGeometry(faces, points);
             }
 
-            fileName outputDir =
-                baseFileDir()/name_/"surface"/obr_.time().timeName();
+            if (Pstream::master())
+            {
+                fileName outputDir =
+                    baseFileDir()/name_/"surface"/obr_.time().timeName();
 
-            surfaceWriterPtr_->write
-            (
-                outputDir,
-                word(sourceTypeNames_[source_]) + "_" + sourceName_,
-                points,
-                faces,
-                fieldName,
-                values,
-                false
-            );
+                surfaceWriterPtr_->write
+                (
+                    outputDir,
+                    word(sourceTypeNames_[source_]) + "_" + sourceName_,
+                    points,
+                    faces,
+                    fieldName,
+                    values,
+                    false
+                );
+            }
         }
 
         // apply scale factor and weight field
diff --git a/src/postProcessing/functionObjects/utilities/Make/files b/src/postProcessing/functionObjects/utilities/Make/files
index f711fc0880616f7edc11475d876a79dac7d76ec1..6a905f28a1e0245d752a0275f83a15469dfdbaa4 100644
--- a/src/postProcessing/functionObjects/utilities/Make/files
+++ b/src/postProcessing/functionObjects/utilities/Make/files
@@ -12,6 +12,9 @@ Peclet/PecletFunctionObject.C
 Q/Q.C
 Q/QFunctionObject.C
 
+blendingFactor/blendingFactor.C
+blendingFactor/blendingFactorFunctionObject.C
+
 DESModelRegions/DESModelRegions.C
 DESModelRegions/DESModelRegionsFunctionObject.C
 
diff --git a/src/postProcessing/functionObjects/utilities/Peclet/Peclet.C b/src/postProcessing/functionObjects/utilities/Peclet/Peclet.C
index 07c7e436b55a4f32b2347162076342c8b0cd25c8..0c77608b13ffb1877685e1884749adfa6b739c0b 100644
--- a/src/postProcessing/functionObjects/utilities/Peclet/Peclet.C
+++ b/src/postProcessing/functionObjects/utilities/Peclet/Peclet.C
@@ -197,12 +197,12 @@ void Foam::Peclet::execute()
 
 void Foam::Peclet::end()
 {
-    // Do nothing - only valid on write
+    // Do nothing
 }
 
 void Foam::Peclet::timeSet()
 {
-    // Do nothing - only valid on write
+    // Do nothing
 }
 
 
diff --git a/src/postProcessing/functionObjects/utilities/blendingFactor/IOblendingFactor.H b/src/postProcessing/functionObjects/utilities/blendingFactor/IOblendingFactor.H
new file mode 100644
index 0000000000000000000000000000000000000000..2d1ae3dc1e4885eeed8272ef93d3331f45a1a17c
--- /dev/null
+++ b/src/postProcessing/functionObjects/utilities/blendingFactor/IOblendingFactor.H
@@ -0,0 +1,49 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Typedef
+    Foam::IOblendingFactor
+
+Description
+    Instance of the generic IOOutputFilter for blendingFactor.
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef IOblendingFactor_H
+#define IOblendingFactor_H
+
+#include "blendingFactor.H"
+#include "IOOutputFilter.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    typedef IOOutputFilter<blendingFactor> IOblendingFactor;
+}
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/postProcessing/functionObjects/utilities/blendingFactor/blendingFactor.C b/src/postProcessing/functionObjects/utilities/blendingFactor/blendingFactor.C
new file mode 100644
index 0000000000000000000000000000000000000000..351c48bfb4b6f4994753dcc7221b1764fed87199
--- /dev/null
+++ b/src/postProcessing/functionObjects/utilities/blendingFactor/blendingFactor.C
@@ -0,0 +1,131 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "blendingFactor.H"
+#include "dictionary.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    defineTypeNameAndDebug(blendingFactor, 0);
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::blendingFactor::blendingFactor
+(
+    const word& name,
+    const objectRegistry& obr,
+    const dictionary& dict,
+    const bool loadFromFiles
+)
+:
+    name_(name),
+    obr_(obr),
+    active_(true),
+    phiName_("unknown-phiName"),
+    fieldName_("unknown-fieldName")
+{
+    // Check if the available mesh is an fvMesh, otherwise deactivate
+    if (!isA<fvMesh>(obr_))
+    {
+        active_ = false;
+        WarningIn
+        (
+            "blendingFactor::blendingFactor"
+            "("
+                "const word&, "
+                "const objectRegistry&, "
+                "const dictionary&, "
+                "const bool"
+            ")"
+        )   << "No fvMesh available, deactivating " << name_ << nl
+            << endl;
+    }
+
+    read(dict);
+}
+
+
+// * * * * * * * * * * * * * * * * Destructor  * * * * * * * * * * * * * * * //
+
+Foam::blendingFactor::~blendingFactor()
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+void Foam::blendingFactor::read(const dictionary& dict)
+{
+    if (active_)
+    {
+        phiName_ = dict.lookupOrDefault<word>("phiName", "phi");
+        dict.lookup("fieldName") >> fieldName_;
+    }
+}
+
+
+void Foam::blendingFactor::execute()
+{
+    if (active_)
+    {
+        calc<scalar>();
+        calc<vector>();
+    }
+}
+
+
+void Foam::blendingFactor::end()
+{
+    // Do nothing
+}
+
+void Foam::blendingFactor::timeSet()
+{
+    // Do nothing
+}
+
+
+void Foam::blendingFactor::write()
+{
+    if (active_)
+    {
+        const word fieldName = "blendingFactor:" + fieldName_;
+
+        const volScalarField& blendingFactor =
+            obr_.lookupObject<volScalarField>(fieldName);
+
+        Info<< type() << " " << name_ << " output:" << nl
+            << "    writing field " << blendingFactor.name() << nl
+            << endl;
+
+        blendingFactor.write();
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/src/postProcessing/functionObjects/utilities/blendingFactor/blendingFactor.H b/src/postProcessing/functionObjects/utilities/blendingFactor/blendingFactor.H
new file mode 100644
index 0000000000000000000000000000000000000000..8b86a25cea60707f2cd5dc7208c6af2344f064b3
--- /dev/null
+++ b/src/postProcessing/functionObjects/utilities/blendingFactor/blendingFactor.H
@@ -0,0 +1,175 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::blendingFactor
+
+Group
+    grpUtilitiesFunctionObjects
+
+Description
+    This function object calculates and outputs the blendingFactor as used by
+    the bended convection schemes.  The output is a volume field (cells) whose
+    value is calculated via the maximum blending factor for any cell face.
+
+
+SourceFiles
+    blendingFactor.C
+    IOblendingFactor.H
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef blendingFactor_H
+#define blendingFactor_H
+
+#include "volFieldsFwd.H"
+#include "surfaceFieldsFwd.H"
+#include "OFstream.H"
+#include "Switch.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+// Forward declaration of classes
+class objectRegistry;
+class dictionary;
+class polyMesh;
+class mapPolyMesh;
+
+/*---------------------------------------------------------------------------*\
+                          Class blendingFactor Declaration
+\*---------------------------------------------------------------------------*/
+
+class blendingFactor
+{
+    // Private data
+
+        //- Name of this set of blendingFactor objects
+        word name_;
+
+        //- Reference to the database
+        const objectRegistry& obr_;
+
+        //- On/off switch
+        bool active_;
+
+        //- Name of flux field, default is "phi"
+        word phiName_;
+
+        //- Field name
+        word fieldName_;
+
+
+    // Private Member Functions
+
+        //- Disallow default bitwise copy construct
+        blendingFactor(const blendingFactor&);
+
+        //- Disallow default bitwise assignment
+        void operator=(const blendingFactor&);
+
+        //- Return the blending factor field from the database
+        template<class Type>
+        volScalarField& factor
+        (
+            const GeometricField<Type, fvPatchField, volMesh>& field
+        );
+
+        //- Calculate the blending factor
+        template<class Type>
+        void calc();
+
+
+public:
+
+    //- Runtime type information
+    TypeName("blendingFactor");
+
+
+    // Constructors
+
+        //- Construct for given objectRegistry and dictionary.
+        //  Allow the possibility to load fields from files
+        blendingFactor
+        (
+            const word& name,
+            const objectRegistry&,
+            const dictionary&,
+            const bool loadFromFiles = false
+        );
+
+
+    //- Destructor
+    virtual ~blendingFactor();
+
+
+    // Member Functions
+
+        //- Return name of the set of blendingFactor
+        virtual const word& name() const
+        {
+            return name_;
+        }
+
+        //- Read the blendingFactor data
+        virtual void read(const dictionary&);
+
+        //- Execute, currently does nothing
+        virtual void execute();
+
+        //- Execute at the final time-loop, currently does nothing
+        virtual void end();
+
+        //- Called when time was set at the end of the Time::operator++
+        virtual void timeSet();
+
+        //- Calculate the blendingFactor and write
+        virtual void write();
+
+        //- Update for changes of mesh
+        virtual void updateMesh(const mapPolyMesh&)
+        {}
+
+        //- Update for changes of mesh
+        virtual void movePoints(const polyMesh&)
+        {}
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#ifdef NoRepository
+    #include "blendingFactorTemplates.C"
+#endif
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/postProcessing/functionObjects/utilities/blendingFactor/blendingFactorFunctionObject.C b/src/postProcessing/functionObjects/utilities/blendingFactor/blendingFactorFunctionObject.C
new file mode 100644
index 0000000000000000000000000000000000000000..6f32ea9c6f5d800583c1f4ef9ac9a387980e25bf
--- /dev/null
+++ b/src/postProcessing/functionObjects/utilities/blendingFactor/blendingFactorFunctionObject.C
@@ -0,0 +1,42 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "blendingFactorFunctionObject.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    defineNamedTemplateTypeNameAndDebug(blendingFactorFunctionObject, 0);
+
+    addToRunTimeSelectionTable
+    (
+        functionObject,
+        blendingFactorFunctionObject,
+        dictionary
+    );
+}
+
+// ************************************************************************* //
diff --git a/src/postProcessing/functionObjects/utilities/blendingFactor/blendingFactorFunctionObject.H b/src/postProcessing/functionObjects/utilities/blendingFactor/blendingFactorFunctionObject.H
new file mode 100644
index 0000000000000000000000000000000000000000..b2e2369ebe191138b2ee919473590a3e917b2096
--- /dev/null
+++ b/src/postProcessing/functionObjects/utilities/blendingFactor/blendingFactorFunctionObject.H
@@ -0,0 +1,54 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Typedef
+    Foam::blendingFactorFunctionObject
+
+Description
+    FunctionObject wrapper around blendingFactor to allow it to be created
+    via the functions entry within controlDict.
+
+SourceFiles
+    blendingFactorFunctionObject.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef blendingFactorFunctionObject_H
+#define blendingFactorFunctionObject_H
+
+#include "blendingFactor.H"
+#include "OutputFilterFunctionObject.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    typedef OutputFilterFunctionObject<blendingFactor>
+        blendingFactorFunctionObject;
+}
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/postProcessing/functionObjects/utilities/blendingFactor/blendingFactorTemplates.C b/src/postProcessing/functionObjects/utilities/blendingFactor/blendingFactorTemplates.C
new file mode 100644
index 0000000000000000000000000000000000000000..3a284b8c731b0d83025cb989674f7c9c93662135
--- /dev/null
+++ b/src/postProcessing/functionObjects/utilities/blendingFactor/blendingFactorTemplates.C
@@ -0,0 +1,119 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "gaussConvectionScheme.H"
+#include "blendedSchemeBase.H"
+#include "fvcCellReduce.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+template<class Type>
+Foam::volScalarField& Foam::blendingFactor::factor
+(
+    const GeometricField<Type, fvPatchField, volMesh>& field
+)
+{
+    const word fieldName = "blendingFactor:" + field.name();
+
+    if (!obr_.foundObject<volScalarField>(fieldName))
+    {
+        const fvMesh& mesh = refCast<const fvMesh>(obr_);
+
+        volScalarField* factorPtr =
+            new volScalarField
+            (
+                IOobject
+                (
+                    fieldName,
+                    mesh.time().timeName(),
+                    mesh,
+                    IOobject::NO_READ,
+                    IOobject::NO_WRITE
+                ),
+                mesh,
+                dimensionedScalar("0", dimless, 0.0),
+                zeroGradientFvPatchScalarField::typeName
+            );
+
+        obr_.store(factorPtr);
+    }
+
+    return
+        const_cast<volScalarField&>
+        (
+            obr_.lookupObject<volScalarField>(fieldName)
+        );
+}
+
+
+template<class Type>
+void Foam::blendingFactor::calc()
+{
+    typedef GeometricField<Type, fvPatchField, volMesh> fieldType;
+
+    if (!obr_.foundObject<fieldType>(fieldName_))
+    {
+        return;
+    }
+
+    const fvMesh& mesh = refCast<const fvMesh>(obr_);
+
+    const fieldType& field = mesh.lookupObject<fieldType>(fieldName_);
+
+    const word divScheme("div(" + phiName_ + ',' + fieldName_ + ')');
+    ITstream& its = mesh.divScheme(divScheme);
+
+    const surfaceScalarField& phi =
+        mesh.lookupObject<surfaceScalarField>(phiName_);
+
+    tmp<fv::convectionScheme<Type> > cs =
+        fv::convectionScheme<Type>::New(mesh, phi, its);
+
+    const fv::gaussConvectionScheme<Type>& gcs =
+        refCast<const fv::gaussConvectionScheme<Type> >(cs());
+
+    const surfaceInterpolationScheme<Type>& interpScheme =
+        gcs.interpScheme();
+
+    if (!isA<blendedSchemeBase<Type> >(interpScheme))
+    {
+        FatalErrorIn("void Foam::blendingFactor::execute()")
+            << interpScheme.typeName << " is not a blended scheme"
+            << exit(FatalError);
+    }
+
+    // retrieve the face-based blending factor
+    const blendedSchemeBase<Type>& blendedScheme =
+        refCast<const blendedSchemeBase<Type> >(interpScheme);
+    const surfaceScalarField factorf(blendedScheme.blendingFactor(field));
+
+    // convert into vol field whose values represent the local face maxima
+    volScalarField& factor = this->factor(field);
+    factor = fvc::cellReduce(factorf, maxEqOp<scalar>());
+    factor.correctBoundaryConditions();
+}
+
+
+// ************************************************************************* //
diff --git a/src/regionModels/Allwmake b/src/regionModels/Allwmake
index 0ca6e6338a93971b6d30465386179a1f088386e2..669b701e81dff16a9623b406501de36dbee8fd25 100755
--- a/src/regionModels/Allwmake
+++ b/src/regionModels/Allwmake
@@ -6,6 +6,7 @@ set -x
 wmake $makeType regionModel
 wmake $makeType pyrolysisModels
 wmake $makeType surfaceFilmModels
+wmake $makeType surfaceFilmModels/derivedFvPatchFields/wallFunctions
 wmake $makeType thermalBaffleModels
 wmake $makeType regionCoupling
 
diff --git a/src/regionModels/surfaceFilmModels/Make/files b/src/regionModels/surfaceFilmModels/Make/files
index 5fe7e8c5e81a46d5315c6ccb03060a41b09e0121..5c535dbf6d26175f096cdfdde8aec1c59368f344 100644
--- a/src/regionModels/surfaceFilmModels/Make/files
+++ b/src/regionModels/surfaceFilmModels/Make/files
@@ -64,10 +64,5 @@ $(PATCHFIELDS)/filmHeightInletVelocity/filmHeightInletVelocityFvPatchVectorField
 $(PATCHFIELDS)/inclinedFilmNusseltHeight/inclinedFilmNusseltHeightFvPatchScalarField.C
 $(PATCHFIELDS)/inclinedFilmNusseltInletVelocity/inclinedFilmNusseltInletVelocityFvPatchVectorField.C
 
-/* Wall functions for primary region */
-WALLFUNCS=$(PATCHFIELDS)/wallFunctions
-$(WALLFUNCS)/alphatFilmWallFunction/alphatFilmWallFunctionFvPatchScalarField.C
-$(WALLFUNCS)/mutkFilmWallFunction/mutkFilmWallFunctionFvPatchScalarField.C
-
 
 LIB = $(FOAM_LIBBIN)/libsurfaceFilmModels
diff --git a/src/regionModels/surfaceFilmModels/Make/options b/src/regionModels/surfaceFilmModels/Make/options
index fc580a43f8046c72a05843029279afc60bc7e6f3..88daf40fd4a6d5d0cc2e54e97dfd2510465ee2ac 100644
--- a/src/regionModels/surfaceFilmModels/Make/options
+++ b/src/regionModels/surfaceFilmModels/Make/options
@@ -10,10 +10,6 @@ EXE_INC = \
     -I$(LIB_SRC)/thermophysicalModels/reactionThermo/lnInclude \
     -I$(LIB_SRC)/thermophysicalModels/SLGThermo/lnInclude \
     -I$(LIB_SRC)/lagrangian/distributionModels/lnInclude \
-    -I$(LIB_SRC)/turbulenceModels \
-    -I$(LIB_SRC)/turbulenceModels/compressible/turbulenceModel/lnInclude \
-    -I$(LIB_SRC)/turbulenceModels/compressible/LES/lnInclude \
-    -I$(LIB_SRC)/turbulenceModels/compressible/RAS/lnInclude \
     -I$(LIB_SRC)/regionModels/regionModel/lnInclude
 
 LIB_LIBS = \
@@ -28,7 +24,4 @@ LIB_LIBS = \
     -lreactionThermophysicalModels \
     -lSLGThermo \
     -ldistributionModels \
-    -lcompressibleTurbulenceModel \
-    -lcompressibleRASModels \
-    -lcompressibleLESModels \
     -lregionModels
diff --git a/src/regionModels/surfaceFilmModels/derivedFvPatchFields/wallFunctions/Make/files b/src/regionModels/surfaceFilmModels/derivedFvPatchFields/wallFunctions/Make/files
new file mode 100644
index 0000000000000000000000000000000000000000..6f150005fd893f833d29b84062e970aec952be17
--- /dev/null
+++ b/src/regionModels/surfaceFilmModels/derivedFvPatchFields/wallFunctions/Make/files
@@ -0,0 +1,5 @@
+alphatFilmWallFunction/alphatFilmWallFunctionFvPatchScalarField.C
+mutkFilmWallFunction/mutkFilmWallFunctionFvPatchScalarField.C
+
+
+LIB = $(FOAM_LIBBIN)/libsurfaceFilmDerivedFvPatchFields
diff --git a/src/regionModels/surfaceFilmModels/derivedFvPatchFields/wallFunctions/Make/options b/src/regionModels/surfaceFilmModels/derivedFvPatchFields/wallFunctions/Make/options
new file mode 100644
index 0000000000000000000000000000000000000000..e894e6d69c740b31365f7bfd0f947f7b874ecc93
--- /dev/null
+++ b/src/regionModels/surfaceFilmModels/derivedFvPatchFields/wallFunctions/Make/options
@@ -0,0 +1,34 @@
+EXE_INC = \
+    -I$(LIB_SRC)/finiteVolume/lnInclude \
+    -I$(LIB_SRC)/meshTools/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/specie/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/properties/liquidProperties/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/properties/liquidMixtureProperties/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/properties/solidProperties/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/properties/solidMixtureProperties/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/reactionThermo/lnInclude \
+    -I$(LIB_SRC)/thermophysicalModels/SLGThermo/lnInclude \
+    -I$(LIB_SRC)/turbulenceModels \
+    -I$(LIB_SRC)/turbulenceModels/compressible/turbulenceModel/lnInclude \
+    -I$(LIB_SRC)/turbulenceModels/compressible/LES/lnInclude \
+    -I$(LIB_SRC)/turbulenceModels/compressible/RAS/lnInclude \
+    -I$(LIB_SRC)/regionModels/regionModel/lnInclude \
+    -I$(LIB_SRC)/regionModels/surfaceFilmModels/lnInclude
+
+LIB_LIBS = \
+    -lfiniteVolume \
+    -lmeshTools \
+    -lfluidThermophysicalModels \
+    -lspecie \
+    -lliquidProperties \
+    -lliquidMixtureProperties \
+    -lsolidProperties \
+    -lsolidMixtureProperties \
+    -lreactionThermophysicalModels \
+    -lSLGThermo \
+    -lcompressibleTurbulenceModel \
+    -lcompressibleRASModels \
+    -lcompressibleLESModels \
+    -lregionModels \
+    -lsurfaceFilmModels
diff --git a/src/sixDoFRigidBodyMotion/Make/files b/src/sixDoFRigidBodyMotion/Make/files
index 022baa43df6e0ebe4c8f36a2193cf8ca7c56418c..8e825f0a010760696e12c38e24e7e3f5f5bf36dc 100644
--- a/src/sixDoFRigidBodyMotion/Make/files
+++ b/src/sixDoFRigidBodyMotion/Make/files
@@ -3,7 +3,7 @@ sixDoFRigidBodyMotion/sixDoFRigidBodyMotionIO.C
 sixDoFRigidBodyMotion/sixDoFRigidBodyMotionState.C
 sixDoFRigidBodyMotion/sixDoFRigidBodyMotionStateIO.C
 
-restraints = sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint
+restraints = sixDoFRigidBodyMotion/restraints
 
 $(restraints)/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint.C
 $(restraints)/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraintNew.C
@@ -11,16 +11,18 @@ $(restraints)/linearAxialAngularSpring/linearAxialAngularSpring.C
 $(restraints)/linearSpring/linearSpring.C
 $(restraints)/sphericalAngularSpring/sphericalAngularSpring.C
 $(restraints)/tabulatedAxialAngularSpring/tabulatedAxialAngularSpring.C
+$(restraints)/linearDamper/linearDamper.C
+$(restraints)/sphericalAngularDamper/sphericalAngularDamper.C
 
-constraints = sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint
+constraints = sixDoFRigidBodyMotion/constraints
 
 $(constraints)/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint.C
 $(constraints)/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraintNew.C
-$(constraints)/fixedAxis/fixedAxis.C
-$(constraints)/fixedLine/fixedLine.C
-$(constraints)/fixedOrientation/fixedOrientation.C
-$(constraints)/fixedPlane/fixedPlane.C
-$(constraints)/fixedPoint/fixedPoint.C
+$(constraints)/axis/sixDoFRigidBodyMotionAxisConstraint.C
+$(constraints)/line/sixDoFRigidBodyMotionLineConstraint.C
+$(constraints)/orientation/sixDoFRigidBodyMotionOrientationConstraint.C
+$(constraints)/plane/sixDoFRigidBodyMotionPlaneConstraint.C
+$(constraints)/point/sixDoFRigidBodyMotionPointConstraint.C
 
 pointPatchFields/derived/sixDoFRigidBodyDisplacement/sixDoFRigidBodyDisplacementPointPatchVectorField.C
 pointPatchFields/derived/uncoupledSixDoFRigidBodyDisplacement/uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField.C
diff --git a/src/sixDoFRigidBodyMotion/pointPatchFields/derived/sixDoFRigidBodyDisplacement/sixDoFRigidBodyDisplacementPointPatchVectorField.C b/src/sixDoFRigidBodyMotion/pointPatchFields/derived/sixDoFRigidBodyDisplacement/sixDoFRigidBodyDisplacementPointPatchVectorField.C
index 559b3cc1752c890b2ce9682cfe50616b7f7bea01..3a6db8083995cdf1385fa5556c38d89d79742dc7 100644
--- a/src/sixDoFRigidBodyMotion/pointPatchFields/derived/sixDoFRigidBodyDisplacement/sixDoFRigidBodyDisplacementPointPatchVectorField.C
+++ b/src/sixDoFRigidBodyMotion/pointPatchFields/derived/sixDoFRigidBodyDisplacement/sixDoFRigidBodyDisplacementPointPatchVectorField.C
@@ -204,10 +204,10 @@ void sixDoFRigidBodyDisplacementPointPatchVectorField::updateCoeffs()
     const pointPatch& ptPatch = this->patch();
 
     // Store the motion state at the beginning of the time-step
-    if (curTimeIndex_ != this->db().time().timeIndex())
+    if (curTimeIndex_ != t.timeIndex())
     {
         motion_.newTime();
-        curTimeIndex_ = this->db().time().timeIndex();
+        curTimeIndex_ = t.timeIndex();
     }
 
     // Patch force data is valid for the current positions, so
@@ -238,7 +238,7 @@ void sixDoFRigidBodyDisplacementPointPatchVectorField::updateCoeffs()
         g_ = g.value();
     }
 
-    // scalar ramp = min(max((this->db().time().value() - 5)/10, 0), 1);
+    // scalar ramp = min(max((t.value() - 5)/10, 0), 1);
     scalar ramp = 1.0;
 
     motion_.updateAcceleration
diff --git a/src/sixDoFRigidBodyMotion/pointPatchFields/derived/uncoupledSixDoFRigidBodyDisplacement/uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField.C b/src/sixDoFRigidBodyMotion/pointPatchFields/derived/uncoupledSixDoFRigidBodyDisplacement/uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField.C
index aaae3592221f01318d9c20ac01cb3f906f5d030a..bb66a5fb14b9d06eee60a94faf153370d27b9986 100644
--- a/src/sixDoFRigidBodyMotion/pointPatchFields/derived/uncoupledSixDoFRigidBodyDisplacement/uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField.C
+++ b/src/sixDoFRigidBodyMotion/pointPatchFields/derived/uncoupledSixDoFRigidBodyDisplacement/uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField.C
@@ -47,7 +47,8 @@ uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField
 :
     fixedValuePointPatchField<vector>(p, iF),
     motion_(),
-    initialPoints_(p.localPoints())
+    initialPoints_(p.localPoints()),
+    curTimeIndex_(-1)
 {}
 
 
@@ -60,7 +61,8 @@ uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField
 )
 :
     fixedValuePointPatchField<vector>(p, iF, dict),
-    motion_(dict, dict)
+    motion_(dict, dict),
+    curTimeIndex_(-1)
 {
     if (!dict.found("value"))
     {
@@ -89,7 +91,8 @@ uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField
 :
     fixedValuePointPatchField<vector>(ptf, p, iF, mapper),
     motion_(ptf.motion_),
-    initialPoints_(ptf.initialPoints_, mapper)
+    initialPoints_(ptf.initialPoints_, mapper),
+    curTimeIndex_(-1)
 {}
 
 
@@ -102,7 +105,8 @@ uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField
 :
     fixedValuePointPatchField<vector>(ptf, iF),
     motion_(ptf.motion_),
-    initialPoints_(ptf.initialPoints_)
+    initialPoints_(ptf.initialPoints_),
+    curTimeIndex_(-1)
 {}
 
 
@@ -147,6 +151,13 @@ void uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField::updateCoeffs()
     const polyMesh& mesh = this->dimensionedInternalField().mesh()();
     const Time& t = mesh.time();
 
+    // Store the motion state at the beginning of the time-step
+    if (curTimeIndex_ != t.timeIndex())
+    {
+        motion_.newTime();
+        curTimeIndex_ = t.timeIndex();
+    }
+
     motion_.updatePosition(t.deltaTValue(), t.deltaT0Value());
 
     vector gravity = vector::zero;
@@ -163,7 +174,8 @@ void uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField::updateCoeffs()
     motion_.updateAcceleration
     (
         gravity*motion_.mass(),
-        vector::zero, t.deltaTValue()
+        vector::zero,
+        t.deltaTValue()
     );
 
     Field<vector>::operator=
diff --git a/src/sixDoFRigidBodyMotion/pointPatchFields/derived/uncoupledSixDoFRigidBodyDisplacement/uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField.H b/src/sixDoFRigidBodyMotion/pointPatchFields/derived/uncoupledSixDoFRigidBodyDisplacement/uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField.H
index 3ffaf25bb52b897940ae5892c7deafab7a18ac4f..bd7538ad7127b2bb617c8562c88f07f4e5c67b88 100644
--- a/src/sixDoFRigidBodyMotion/pointPatchFields/derived/uncoupledSixDoFRigidBodyDisplacement/uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField.H
+++ b/src/sixDoFRigidBodyMotion/pointPatchFields/derived/uncoupledSixDoFRigidBodyDisplacement/uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField.H
@@ -59,6 +59,9 @@ class uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField
         //- Initial positions of points on the patch
         pointField initialPoints_;
 
+        //- Current time index (used for updating)
+        label curTimeIndex_;
+
 
 public:
 
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/axis/sixDoFRigidBodyMotionAxisConstraint.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/axis/sixDoFRigidBodyMotionAxisConstraint.C
new file mode 100644
index 0000000000000000000000000000000000000000..9154e51216a7e3d2b1127b0ce6c5c919318c67dd
--- /dev/null
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/axis/sixDoFRigidBodyMotionAxisConstraint.C
@@ -0,0 +1,128 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "sixDoFRigidBodyMotionAxisConstraint.H"
+#include "addToRunTimeSelectionTable.H"
+#include "sixDoFRigidBodyMotion.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace sixDoFRigidBodyMotionConstraints
+{
+    defineTypeNameAndDebug(axis, 0);
+
+    addToRunTimeSelectionTable
+    (
+        sixDoFRigidBodyMotionConstraint,
+        axis,
+        dictionary
+    );
+}
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::sixDoFRigidBodyMotionConstraints::axis::axis
+(
+    const word& name,
+    const dictionary& sDoFRBMCDict
+)
+:
+    sixDoFRigidBodyMotionConstraint(name, sDoFRBMCDict),
+    axis_()
+{
+    read(sDoFRBMCDict);
+}
+
+
+// * * * * * * * * * * * * * * * * Destructors * * * * * * * * * * * * * * * //
+
+Foam::sixDoFRigidBodyMotionConstraints::axis::~axis()
+{}
+
+
+// * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
+
+void Foam::sixDoFRigidBodyMotionConstraints::axis::constrainTranslation
+(
+    pointConstraint& pc
+) const
+{}
+
+
+void Foam::sixDoFRigidBodyMotionConstraints::axis::constrainRotation
+(
+    pointConstraint& pc
+) const
+{
+    pc.combine(pointConstraint(Tuple2<label, vector>(2, vector(0,1,0))));
+}
+
+
+bool Foam::sixDoFRigidBodyMotionConstraints::axis::read
+(
+    const dictionary& sDoFRBMCDict
+)
+{
+    sixDoFRigidBodyMotionConstraint::read(sDoFRBMCDict);
+
+    sDoFRBMCCoeffs_.lookup("axis") >> axis_;
+
+    scalar magFixedAxis(mag(axis_));
+
+    if (magFixedAxis > VSMALL)
+    {
+        axis_ /= magFixedAxis;
+    }
+    else
+    {
+        FatalErrorIn
+        (
+            "Foam::sixDoFRigidBodyMotionConstraints::axis::read"
+            "("
+                "const dictionary& sDoFRBMCDict"
+            ")"
+        )
+            << "axis has zero length"
+            << abort(FatalError);
+    }
+
+    return true;
+}
+
+
+void Foam::sixDoFRigidBodyMotionConstraints::axis::write
+(
+    Ostream& os
+) const
+{
+    os.writeKeyword("axis")
+        << axis_ << token::END_STATEMENT << nl;
+}
+
+// ************************************************************************* //
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedAxis/fixedAxis.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/axis/sixDoFRigidBodyMotionAxisConstraint.H
similarity index 74%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedAxis/fixedAxis.H
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/axis/sixDoFRigidBodyMotionAxisConstraint.H
index 7772833f4d53fccb4f81be74b404cc92c9433e2e..291c3421f86d1b9111db2297cac8bd78b41e96f1 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedAxis/fixedAxis.H
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/axis/sixDoFRigidBodyMotionAxisConstraint.H
@@ -22,23 +22,21 @@ License
     along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
 
 Class
-    Foam::sixDoFRigidBodyMotionConstraints::fixedAxis
+    Foam::sixDoFRigidBodyMotionConstraints::axis
 
 Description
     sixDoFRigidBodyMotionConstraint.  Body may only rotate around
     an axis fixed in global space.
 
 SourceFiles
-    fixedAxis.C
+    sixDoFRigidBodyMotionAxisConstraint.C
 
 \*---------------------------------------------------------------------------*/
 
-#ifndef fixedAxis_H
-#define fixedAxis_H
+#ifndef sixDoFRigidBodyMotionAxisConstraint_H
+#define sixDoFRigidBodyMotionAxisConstraint_H
 
 #include "sixDoFRigidBodyMotionConstraint.H"
-#include "point.H"
-#include "tensor.H"
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
@@ -49,10 +47,10 @@ namespace sixDoFRigidBodyMotionConstraints
 {
 
 /*---------------------------------------------------------------------------*\
-                            Class fixedAxis Declaration
+                            Class axis Declaration
 \*---------------------------------------------------------------------------*/
 
-class fixedAxis
+class axis
 :
     public sixDoFRigidBodyMotionConstraint
 {
@@ -60,20 +58,21 @@ class fixedAxis
     // Private data
 
         //- Reference axis in global space
-        vector fixedAxis_;
+        vector axis_;
 
 
 public:
 
     //- Runtime type information
-    TypeName("fixedAxis");
+    TypeName("axis");
 
 
     // Constructors
 
         //- Construct from components
-        fixedAxis
+        axis
         (
+            const word& name,
             const dictionary& sDoFRBMCDict
         );
 
@@ -82,30 +81,22 @@ public:
         {
             return autoPtr<sixDoFRigidBodyMotionConstraint>
             (
-                new fixedAxis(*this)
+                new axis(*this)
             );
         }
 
 
     //- Destructor
-    virtual ~fixedAxis();
+    virtual ~axis();
 
 
     // Member Functions
 
-        //- Calculate the constraint position, force and moment.
-        //  Global reference frame vectors.  Returns boolean stating
-        //  whether the constraint been converged to tolerance.
-        virtual bool constrain
-        (
-            const sixDoFRigidBodyMotion& motion,
-            const vector& existingConstraintForce,
-            const vector& existingConstraintMoment,
-            scalar deltaT,
-            vector& constraintPosition,
-            vector& constraintForceIncrement,
-            vector& constraintMomentIncrement
-        ) const;
+        //- Apply and accumulate translational constraints
+        virtual void constrainTranslation(pointConstraint&) const;
+
+        //- Apply and accumulate rotational constraints
+        virtual void constrainRotation(pointConstraint&) const;
 
         //- Update properties from given dictionary
         virtual bool read(const dictionary& sDoFRBMCCoeff);
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedLine/fixedLine.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/line/sixDoFRigidBodyMotionLineConstraint.C
similarity index 55%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedLine/fixedLine.C
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/line/sixDoFRigidBodyMotionLineConstraint.C
index f77afa2b10ade1dc45492a1995ab8dd67f2fd1da..ff056c259168321f5e19e27d2ecba98ec0d34707 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedLine/fixedLine.C
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/line/sixDoFRigidBodyMotionLineConstraint.C
@@ -23,7 +23,7 @@ License
 
 \*---------------------------------------------------------------------------*/
 
-#include "fixedLine.H"
+#include "sixDoFRigidBodyMotionLineConstraint.H"
 #include "addToRunTimeSelectionTable.H"
 #include "sixDoFRigidBodyMotion.H"
 
@@ -33,12 +33,12 @@ namespace Foam
 {
 namespace sixDoFRigidBodyMotionConstraints
 {
-    defineTypeNameAndDebug(fixedLine, 0);
+    defineTypeNameAndDebug(line, 0);
 
     addToRunTimeSelectionTable
     (
         sixDoFRigidBodyMotionConstraint,
-        fixedLine,
+        line,
         dictionary
     );
 }
@@ -47,13 +47,13 @@ namespace sixDoFRigidBodyMotionConstraints
 
 // * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
 
-Foam::sixDoFRigidBodyMotionConstraints::fixedLine::fixedLine
+Foam::sixDoFRigidBodyMotionConstraints::line::line
 (
+    const word& name,
     const dictionary& sDoFRBMCDict
 )
 :
-    sixDoFRigidBodyMotionConstraint(sDoFRBMCDict),
-    refPt_(),
+    sixDoFRigidBodyMotionConstraint(name, sDoFRBMCDict),
     dir_()
 {
     read(sDoFRBMCDict);
@@ -62,82 +62,35 @@ Foam::sixDoFRigidBodyMotionConstraints::fixedLine::fixedLine
 
 // * * * * * * * * * * * * * * * * Destructors * * * * * * * * * * * * * * * //
 
-Foam::sixDoFRigidBodyMotionConstraints::fixedLine::~fixedLine()
+Foam::sixDoFRigidBodyMotionConstraints::line::~line()
 {}
 
 
 // * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
 
-bool Foam::sixDoFRigidBodyMotionConstraints::fixedLine::constrain
+void Foam::sixDoFRigidBodyMotionConstraints::line::constrainTranslation
 (
-    const sixDoFRigidBodyMotion& motion,
-    const vector& existingConstraintForce,
-    const vector& existingConstraintMoment,
-    scalar deltaT,
-    vector& constraintPosition,
-    vector& constraintForceIncrement,
-    vector& constraintMomentIncrement
+    pointConstraint& pc
 ) const
 {
-    point predictedPosition = motion.predictedPosition
-    (
-        refPt_,
-        existingConstraintForce,
-        existingConstraintMoment,
-        deltaT
-    );
-
-    constraintPosition = motion.currentPosition(refPt_);
-
-    // Info<< "current position " << constraintPosition << nl
-    //     << "next predictedPosition " << predictedPosition
-    //     << endl;
-
-    // Vector from reference point to predicted point
-    vector rC = predictedPosition - refPt_;
-
-    vector error = rC - ((rC) & dir_)*dir_;
-
-    // Info<< "error " << error << endl;
-
-    constraintForceIncrement =
-        -relaxationFactor_*error*motion.mass()/sqr(deltaT);
-
-    constraintMomentIncrement = vector::zero;
-
-    bool converged(mag(error) < tolerance_);
+    pc.combine(pointConstraint(Tuple2<label, vector>(2, dir_)));
+}
 
-    if (sixDoFRigidBodyMotionConstraint::debug)
-    {
-        Info<< " error " << error
-            << " force " << constraintForceIncrement
-            << " moment " << constraintMomentIncrement;
-
-        if (converged)
-        {
-            Info<< " converged";
-        }
-        else
-        {
-            Info<< " not converged";
-        }
-
-        Info<< endl;
-    }
 
-    return converged;
-}
+void Foam::sixDoFRigidBodyMotionConstraints::line::constrainRotation
+(
+    pointConstraint& pc
+) const
+{}
 
 
-bool Foam::sixDoFRigidBodyMotionConstraints::fixedLine::read
+bool Foam::sixDoFRigidBodyMotionConstraints::line::read
 (
     const dictionary& sDoFRBMCDict
 )
 {
     sixDoFRigidBodyMotionConstraint::read(sDoFRBMCDict);
 
-    sDoFRBMCCoeffs_.lookup("refPoint") >> refPt_;
-
     sDoFRBMCCoeffs_.lookup("direction") >> dir_;
 
     scalar magDir(mag(dir_));
@@ -150,7 +103,7 @@ bool Foam::sixDoFRigidBodyMotionConstraints::fixedLine::read
     {
         FatalErrorIn
         (
-            "Foam::sixDoFRigidBodyMotionConstraints::fixedLine::read"
+            "Foam::sixDoFRigidBodyMotionConstraints::line::read"
             "("
                 "const dictionary& sDoFRBMCDict"
             ")"
@@ -163,14 +116,11 @@ bool Foam::sixDoFRigidBodyMotionConstraints::fixedLine::read
 }
 
 
-void Foam::sixDoFRigidBodyMotionConstraints::fixedLine::write
+void Foam::sixDoFRigidBodyMotionConstraints::line::write
 (
     Ostream& os
 ) const
 {
-    os.writeKeyword("refPoint")
-        << refPt_ << token::END_STATEMENT << nl;
-
     os.writeKeyword("direction")
         << dir_ << token::END_STATEMENT << nl;
 }
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedLine/fixedLine.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/line/sixDoFRigidBodyMotionLineConstraint.H
similarity index 74%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedLine/fixedLine.H
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/line/sixDoFRigidBodyMotionLineConstraint.H
index 8d0710e0908780deb5364a99e63c4f5ab695e388..7d4919072024d5803ab23fdbf23ebc5886aaf2ae 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedLine/fixedLine.H
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/line/sixDoFRigidBodyMotionLineConstraint.H
@@ -22,22 +22,21 @@ License
     along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
 
 Class
-    Foam::sixDoFRigidBodyMotionConstraints::fixedLine
+    Foam::sixDoFRigidBodyMotionConstraints::line
 
 Description
     sixDoFRigidBodyMotionConstraint.  Reference point may only move
     along a line.
 
 SourceFiles
-    fixedLine.C
+    sixDoFRigidBodyMotionLineConstraint.C
 
 \*---------------------------------------------------------------------------*/
 
-#ifndef fixedLine_H
-#define fixedLine_H
+#ifndef sixDoFRigidBodyMotionLineConstraint_H
+#define sixDoFRigidBodyMotionLineConstraint_H
 
 #include "sixDoFRigidBodyMotionConstraint.H"
-#include "point.H"
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
@@ -48,18 +47,15 @@ namespace sixDoFRigidBodyMotionConstraints
 {
 
 /*---------------------------------------------------------------------------*\
-                          Class fixedLine Declaration
+                          Class line Declaration
 \*---------------------------------------------------------------------------*/
 
-class fixedLine
+class line
 :
     public sixDoFRigidBodyMotionConstraint
 {
     // Private data
 
-        //- Reference point for the constraining line
-        point refPt_;
-
         //- Direction of the constraining line
         vector dir_;
 
@@ -67,14 +63,15 @@ class fixedLine
 public:
 
     //- Runtime type information
-    TypeName("fixedLine");
+    TypeName("line");
 
 
     // Constructors
 
         //- Construct from components
-        fixedLine
+        line
         (
+            const word& name,
             const dictionary& sDoFRBMCDict
         );
 
@@ -83,30 +80,22 @@ public:
         {
             return autoPtr<sixDoFRigidBodyMotionConstraint>
             (
-                new fixedLine(*this)
+                new line(*this)
             );
         }
 
 
     //- Destructor
-    virtual ~fixedLine();
+    virtual ~line();
 
 
     // Member Functions
 
-        //- Calculate the constraint position, force and moment.
-        //  Global reference frame vectors.  Returns boolean stating
-        //  whether the constraint been converged to tolerance.
-        virtual bool constrain
-        (
-            const sixDoFRigidBodyMotion& motion,
-            const vector& existingConstraintForce,
-            const vector& existingConstraintMoment,
-            scalar deltaT,
-            vector& constraintPosition,
-            vector& constraintForceIncrement,
-            vector& constraintMomentIncrement
-        ) const;
+        //- Apply and accumulate translational constraints
+        virtual void constrainTranslation(pointConstraint&) const;
+
+        //- Apply and accumulate rotational constraints
+        virtual void constrainRotation(pointConstraint&) const;
 
         //- Update properties from given dictionary
         virtual bool read(const dictionary& sDoFRBMCCoeff);
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/orientation/sixDoFRigidBodyMotionOrientationConstraint.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/orientation/sixDoFRigidBodyMotionOrientationConstraint.C
new file mode 100644
index 0000000000000000000000000000000000000000..28bf1c48117067ae84a264c138333569f7206198
--- /dev/null
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/orientation/sixDoFRigidBodyMotionOrientationConstraint.C
@@ -0,0 +1,106 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "sixDoFRigidBodyMotionOrientationConstraint.H"
+#include "addToRunTimeSelectionTable.H"
+#include "sixDoFRigidBodyMotion.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace sixDoFRigidBodyMotionConstraints
+{
+    defineTypeNameAndDebug(orientation, 0);
+
+    addToRunTimeSelectionTable
+    (
+        sixDoFRigidBodyMotionConstraint,
+        orientation,
+        dictionary
+    );
+}
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::sixDoFRigidBodyMotionConstraints::orientation::orientation
+(
+    const word& name,
+    const dictionary& sDoFRBMCDict
+)
+:
+    sixDoFRigidBodyMotionConstraint(name, sDoFRBMCDict)
+{
+    read(sDoFRBMCDict);
+}
+
+
+// * * * * * * * * * * * * * * * * Destructors * * * * * * * * * * * * * * * //
+
+Foam::sixDoFRigidBodyMotionConstraints::orientation::~orientation()
+{}
+
+
+// * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
+
+void Foam::sixDoFRigidBodyMotionConstraints::orientation::
+constrainTranslation
+(
+    pointConstraint& pc
+) const
+{}
+
+
+void Foam::sixDoFRigidBodyMotionConstraints::orientation::
+constrainRotation
+(
+    pointConstraint& pc
+) const
+{
+    pc.combine(pointConstraint(Tuple2<label, vector>(3, vector::zero)));
+}
+
+
+bool Foam::sixDoFRigidBodyMotionConstraints::orientation::read
+(
+    const dictionary& sDoFRBMCDict
+)
+{
+    sixDoFRigidBodyMotionConstraint::read(sDoFRBMCDict);
+
+    return true;
+}
+
+
+void Foam::sixDoFRigidBodyMotionConstraints::orientation::write
+(
+    Ostream& os
+) const
+{
+}
+
+// ************************************************************************* //
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedOrientation/fixedOrientation.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/orientation/sixDoFRigidBodyMotionOrientationConstraint.H
similarity index 69%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedOrientation/fixedOrientation.H
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/orientation/sixDoFRigidBodyMotionOrientationConstraint.H
index fcf7a62167ac24d29205cc07a68cd133c0d4a89a..5a41498e9528dfdfc3c4c5a2fd98718f9f49ee86 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedOrientation/fixedOrientation.H
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/orientation/sixDoFRigidBodyMotionOrientationConstraint.H
@@ -22,24 +22,20 @@ License
     along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
 
 Class
-    Foam::sixDoFRigidBodyMotionConstraints::fixedOrientation
+    Foam::sixDoFRigidBodyMotionConstraints::orientation
 
 Description
-    sixDoFRigidBodyMotionConstraint.  Orientation of body fixed global
-    space. Only valid where the predicted deviation from alignment is
-    < 90 degrees.
+    Fix orientation of body in global space.
 
 SourceFiles
-    fixedOrientation.C
+    sixDoFRigidBodyMotionOrientationConstraint.C
 
 \*---------------------------------------------------------------------------*/
 
-#ifndef fixedOrientation_H
-#define fixedOrientation_H
+#ifndef sixDoFRigidBodyMotionOrientationConstraint_H
+#define sixDoFRigidBodyMotionOrientationConstraint_H
 
 #include "sixDoFRigidBodyMotionConstraint.H"
-#include "point.H"
-#include "tensor.H"
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
@@ -50,10 +46,10 @@ namespace sixDoFRigidBodyMotionConstraints
 {
 
 /*---------------------------------------------------------------------------*\
-                       Class fixedOrientation Declaration
+                       Class orientation Declaration
 \*---------------------------------------------------------------------------*/
 
-class fixedOrientation
+class orientation
 :
     public sixDoFRigidBodyMotionConstraint
 {
@@ -61,14 +57,15 @@ class fixedOrientation
 public:
 
     //- Runtime type information
-    TypeName("fixedOrientation");
+    TypeName("orientation");
 
 
     // Constructors
 
         //- Construct from components
-        fixedOrientation
+        orientation
         (
+            const word& name,
             const dictionary& sDoFRBMCDict
         );
 
@@ -77,30 +74,22 @@ public:
         {
             return autoPtr<sixDoFRigidBodyMotionConstraint>
             (
-                new fixedOrientation(*this)
+                new orientation(*this)
             );
         }
 
 
     //- Destructor
-    virtual ~fixedOrientation();
+    virtual ~orientation();
 
 
     // Member Functions
 
-        //- Calculate the constraint position, force and moment.
-        //  Global reference frame vectors.  Returns boolean stating
-        //  whether the constraint been converged to tolerance.
-        virtual bool constrain
-        (
-            const sixDoFRigidBodyMotion& motion,
-            const vector& existingConstraintForce,
-            const vector& existingConstraintMoment,
-            scalar deltaT,
-            vector& constraintPosition,
-            vector& constraintForceIncrement,
-            vector& constraintMomentIncrement
-        ) const;
+        //- Apply and accumulate translational constraints
+        virtual void constrainTranslation(pointConstraint&) const;
+
+        //- Apply and accumulate rotational constraints
+        virtual void constrainRotation(pointConstraint&) const;
 
         //- Update properties from given dictionary
         virtual bool read(const dictionary& sDoFRBMCCoeff);
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/plane/sixDoFRigidBodyMotionPlaneConstraint.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/plane/sixDoFRigidBodyMotionPlaneConstraint.C
new file mode 100644
index 0000000000000000000000000000000000000000..286e279b77da5ecb37f49ef9a838645db6e2c743
--- /dev/null
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/plane/sixDoFRigidBodyMotionPlaneConstraint.C
@@ -0,0 +1,109 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "sixDoFRigidBodyMotionPlaneConstraint.H"
+#include "addToRunTimeSelectionTable.H"
+#include "sixDoFRigidBodyMotion.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace sixDoFRigidBodyMotionConstraints
+{
+    defineTypeNameAndDebug(plane, 0);
+
+    addToRunTimeSelectionTable
+    (
+        sixDoFRigidBodyMotionConstraint,
+        plane,
+        dictionary
+    );
+}
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::sixDoFRigidBodyMotionConstraints::plane::plane
+(
+    const word& name,
+    const dictionary& sDoFRBMCDict
+)
+:
+    sixDoFRigidBodyMotionConstraint(name, sDoFRBMCDict),
+    normal_(vector::zero)
+{
+    read(sDoFRBMCDict);
+}
+
+
+// * * * * * * * * * * * * * * * * Destructors * * * * * * * * * * * * * * * //
+
+Foam::sixDoFRigidBodyMotionConstraints::plane::~plane()
+{}
+
+
+// * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
+
+void Foam::sixDoFRigidBodyMotionConstraints::plane::constrainTranslation
+(
+    pointConstraint& pc
+) const
+{
+    pc.applyConstraint(normal_);
+}
+
+
+void Foam::sixDoFRigidBodyMotionConstraints::plane::constrainRotation
+(
+    pointConstraint& pc
+) const
+{}
+
+
+bool Foam::sixDoFRigidBodyMotionConstraints::plane::read
+(
+    const dictionary& sDoFRBMCDict
+)
+{
+    sixDoFRigidBodyMotionConstraint::read(sDoFRBMCDict);
+
+    normal_ = sDoFRBMCCoeffs_.lookup("normal");
+
+    return true;
+}
+
+
+void Foam::sixDoFRigidBodyMotionConstraints::plane::write
+(
+    Ostream& os
+) const
+{
+    os.writeKeyword("normal")
+        << normal_ << token::END_STATEMENT << nl;
+}
+
+// ************************************************************************* //
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedPlane/fixedPlane.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/plane/sixDoFRigidBodyMotionPlaneConstraint.H
similarity index 72%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedPlane/fixedPlane.H
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/plane/sixDoFRigidBodyMotionPlaneConstraint.H
index b7f100ac5eae4e7dfd6d0d556dbe702fe8cdf055..1467e54e783597ac70034bba7840a8121a605c1d 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedPlane/fixedPlane.H
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/plane/sixDoFRigidBodyMotionPlaneConstraint.H
@@ -22,22 +22,21 @@ License
     along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
 
 Class
-    Foam::sixDoFRigidBodyMotionConstraints::fixedPlane
+    Foam::sixDoFRigidBodyMotionConstraints::plane
 
 Description
     sixDoFRigidBodyMotionConstraint.  Reference point may only move
     along a plane.
 
 SourceFiles
-    fixedPlane.C
+    sixDoFRigidBodyMotionPlaneConstraint.C
 
 \*---------------------------------------------------------------------------*/
 
-#ifndef fixedPlane_H
-#define fixedPlane_H
+#ifndef sixDoFRigidBodyMotionPlaneConstraint_H
+#define sixDoFRigidBodyMotionPlaneConstraint_H
 
 #include "sixDoFRigidBodyMotionConstraint.H"
-#include "plane.H"
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
@@ -48,31 +47,31 @@ namespace sixDoFRigidBodyMotionConstraints
 {
 
 /*---------------------------------------------------------------------------*\
-                          Class fixedPlane Declaration
+                          Class plane Declaration
 \*---------------------------------------------------------------------------*/
 
-class fixedPlane
+class plane
 :
     public sixDoFRigidBodyMotionConstraint
 {
     // Private data
 
-        //- Plane which the transformed reference point is constrained
-        //  to move along
-        plane fixedPlane_;
+        //- Normal to plane
+        vector normal_;
 
 
 public:
 
     //- Runtime type information
-    TypeName("fixedPlane");
+    TypeName("plane");
 
 
     // Constructors
 
         //- Construct from components
-        fixedPlane
+        plane
         (
+            const word& name,
             const dictionary& sDoFRBMCDict
         );
 
@@ -81,30 +80,22 @@ public:
         {
             return autoPtr<sixDoFRigidBodyMotionConstraint>
             (
-                new fixedPlane(*this)
+                new plane(*this)
             );
         }
 
 
     //- Destructor
-    virtual ~fixedPlane();
+    virtual ~plane();
 
 
     // Member Functions
 
-        //- Calculate the constraint position, force and moment.
-        //  Global reference frame vectors.  Returns boolean stating
-        //  whether the constraint been converged to tolerance.
-        virtual bool constrain
-        (
-            const sixDoFRigidBodyMotion& motion,
-            const vector& existingConstraintForce,
-            const vector& existingConstraintMoment,
-            scalar deltaT,
-            vector& constraintPosition,
-            vector& constraintForceIncrement,
-            vector& constraintMomentIncrement
-        ) const;
+        //- Apply and accumulate translational constraints
+        virtual void constrainTranslation(pointConstraint&) const;
+
+        //- Apply and accumulate rotational constraints
+        virtual void constrainRotation(pointConstraint&) const;
 
         //- Update properties from given dictionary
         virtual bool read(const dictionary& sDoFRBMCCoeff);
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/point/sixDoFRigidBodyMotionPointConstraint.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/point/sixDoFRigidBodyMotionPointConstraint.C
new file mode 100644
index 0000000000000000000000000000000000000000..1068b01af46773777652e2b11b2764cd675fcc59
--- /dev/null
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/point/sixDoFRigidBodyMotionPointConstraint.C
@@ -0,0 +1,109 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "sixDoFRigidBodyMotionPointConstraint.H"
+#include "addToRunTimeSelectionTable.H"
+#include "sixDoFRigidBodyMotion.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace sixDoFRigidBodyMotionConstraints
+{
+    defineTypeNameAndDebug(point, 0);
+
+    addToRunTimeSelectionTable
+    (
+        sixDoFRigidBodyMotionConstraint,
+        point,
+        dictionary
+    );
+}
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::sixDoFRigidBodyMotionConstraints::point::point
+(
+    const word& name,
+    const dictionary& sDoFRBMCDict
+)
+:
+    sixDoFRigidBodyMotionConstraint(name, sDoFRBMCDict),
+    point_()
+{
+    read(sDoFRBMCDict);
+}
+
+
+// * * * * * * * * * * * * * * * * Destructors * * * * * * * * * * * * * * * //
+
+Foam::sixDoFRigidBodyMotionConstraints::point::~point()
+{}
+
+
+// * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
+
+void Foam::sixDoFRigidBodyMotionConstraints::point::constrainTranslation
+(
+    pointConstraint& pc
+) const
+{
+    pc.combine(pointConstraint(Tuple2<label, vector>(3, vector::zero)));
+}
+
+
+void Foam::sixDoFRigidBodyMotionConstraints::point::constrainRotation
+(
+    pointConstraint& pc
+) const
+{}
+
+
+bool Foam::sixDoFRigidBodyMotionConstraints::point::read
+(
+    const dictionary& sDoFRBMCDict
+)
+{
+    sixDoFRigidBodyMotionConstraint::read(sDoFRBMCDict);
+
+    sDoFRBMCCoeffs_.lookup("point") >> point_;
+
+    return true;
+}
+
+
+void Foam::sixDoFRigidBodyMotionConstraints::point::write
+(
+    Ostream& os
+) const
+{
+    os.writeKeyword("point")
+        << point_ << token::END_STATEMENT << nl;
+}
+
+// ************************************************************************* //
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedPoint/fixedPoint.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/point/sixDoFRigidBodyMotionPointConstraint.H
similarity index 74%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedPoint/fixedPoint.H
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/point/sixDoFRigidBodyMotionPointConstraint.H
index c361d3a8b3d0ad730ec293f2fdc39b02c50f379a..39200c0c5cb9cc3ac2018b5a49199d5ecd4257ea 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedPoint/fixedPoint.H
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/point/sixDoFRigidBodyMotionPointConstraint.H
@@ -22,18 +22,18 @@ License
     along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
 
 Class
-    Foam::sixDoFRigidBodyMotionConstraints::fixedPoint
+    Foam::sixDoFRigidBodyMotionConstraints::point
 
 Description
-    sixDoFRigidBodyMotionConstraint.  Point fixed in space.
+    Point fixed in space.
 
 SourceFiles
-    fixedPoint.C
+    sixDoFRigidBodyMotionPointConstraint.C
 
 \*---------------------------------------------------------------------------*/
 
-#ifndef fixedPoint_H
-#define fixedPoint_H
+#ifndef sixDoFRigidBodyMotionPointConstraint_H
+#define sixDoFRigidBodyMotionPointConstraint_H
 
 #include "sixDoFRigidBodyMotionConstraint.H"
 #include "point.H"
@@ -47,10 +47,10 @@ namespace sixDoFRigidBodyMotionConstraints
 {
 
 /*---------------------------------------------------------------------------*\
-                           Class fixedPoint Declaration
+                           Class point Declaration
 \*---------------------------------------------------------------------------*/
 
-class fixedPoint
+class point
 :
     public sixDoFRigidBodyMotionConstraint
 {
@@ -60,20 +60,21 @@ class fixedPoint
         //  it so that this point remains fixed.  This serves as the
         //  reference point for displacements as well as the target
         //  position.
-        point fixedPoint_;
+        Foam::point point_;
 
 
 public:
 
     //- Runtime type information
-    TypeName("fixedPoint");
+    TypeName("point");
 
 
     // Constructors
 
         //- Construct from components
-        fixedPoint
+        point
         (
+            const word& name,
             const dictionary& sDoFRBMCDict
         );
 
@@ -82,30 +83,22 @@ public:
         {
             return autoPtr<sixDoFRigidBodyMotionConstraint>
             (
-                new fixedPoint(*this)
+                new point(*this)
             );
         }
 
 
     //- Destructor
-    virtual ~fixedPoint();
+    virtual ~point();
 
 
     // Member Functions
 
-        //- Calculate the constraint position, force and moment.
-        //  Global reference frame vectors.  Returns boolean stating
-        //  whether the constraint been converged to tolerance.
-        virtual bool constrain
-        (
-            const sixDoFRigidBodyMotion& motion,
-            const vector& existingConstraintForce,
-            const vector& existingConstraintMoment,
-            scalar deltaT,
-            vector& constraintPosition,
-            vector& constraintForceIncrement,
-            vector& constraintMomentIncrement
-        ) const;
+        //- Apply and accumulate translational constraints
+        virtual void constrainTranslation(pointConstraint&) const;
+
+        //- Apply and accumulate rotational constraints
+        virtual void constrainRotation(pointConstraint&) const;
 
         //- Update properties from given dictionary
         virtual bool read(const dictionary& sDoFRBMCCoeff);
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint.C
similarity index 68%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint.C
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint.C
index 22299c7f3c8cc3f2dc1b7fca94aa554a3c975665..10044ac8328eddf04e50a89d5575cd1343d88cec 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint.C
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint.C
@@ -29,9 +29,8 @@ License
 
 namespace Foam
 {
-defineTypeNameAndDebug(sixDoFRigidBodyMotionConstraint, 0);
-
-defineRunTimeSelectionTable(sixDoFRigidBodyMotionConstraint, dictionary);
+    defineTypeNameAndDebug(sixDoFRigidBodyMotionConstraint, 0);
+    defineRunTimeSelectionTable(sixDoFRigidBodyMotionConstraint, dictionary);
 }
 
 
@@ -39,22 +38,12 @@ defineRunTimeSelectionTable(sixDoFRigidBodyMotionConstraint, dictionary);
 
 Foam::sixDoFRigidBodyMotionConstraint::sixDoFRigidBodyMotionConstraint
 (
+    const word& name,
     const dictionary& sDoFRBMCDict
 )
 :
-    sDoFRBMCCoeffs_
-    (
-        sDoFRBMCDict.subDict
-        (
-            word(sDoFRBMCDict.lookup("sixDoFRigidBodyMotionConstraint"))
-          + "Coeffs"
-        )
-    ),
-    tolerance_(readScalar(sDoFRBMCDict.lookup("tolerance"))),
-    relaxationFactor_
-    (
-        sDoFRBMCDict.lookupOrDefault<scalar>("relaxationFactor", 1)
-    )
+    name_(name),
+    sDoFRBMCCoeffs_(sDoFRBMCDict)
 {}
 
 
@@ -71,27 +60,14 @@ bool Foam::sixDoFRigidBodyMotionConstraint::read
     const dictionary& sDoFRBMCDict
 )
 {
-    tolerance_ = (readScalar(sDoFRBMCDict.lookup("tolerance")));
-
-    relaxationFactor_ = sDoFRBMCDict.lookupOrDefault<scalar>
-    (
-        "relaxationFactor",
-        1
-    );
-
-    sDoFRBMCCoeffs_ = sDoFRBMCDict.subDict(type() + "Coeffs");
+    sDoFRBMCCoeffs_ = sDoFRBMCDict;
 
     return true;
 }
 
 
 void Foam::sixDoFRigidBodyMotionConstraint::write(Ostream& os) const
-{
-    os.writeKeyword("tolerance")
-        << tolerance_ << token::END_STATEMENT << nl;
+{}
 
-    os.writeKeyword("relaxationFactor")
-        << relaxationFactor_ << token::END_STATEMENT << nl;
-}
 
 // ************************************************************************* //
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint.H
similarity index 75%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint.H
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint.H
index b1f5438948cf5ad3bd255f1e403db4a28d4f90ad..b4eed214f9db1ad4eb8c883862f0127cc35c283d 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint.H
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint.H
@@ -46,7 +46,7 @@ SourceFiles
 #include "Time.H"
 #include "dictionary.H"
 #include "autoPtr.H"
-#include "vector.H"
+#include "pointConstraint.H"
 #include "runTimeSelectionTables.H"
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@@ -69,16 +69,12 @@ protected:
 
     // Protected data
 
+        //- Name of the constraint
+        word name_;
+
         //- Constraint model specific coefficient dictionary
         dictionary sDoFRBMCCoeffs_;
 
-        //- Solution tolerance.  Meaning depends on model, usually an
-        //  absolute distance or angle.
-        scalar tolerance_;
-
-        //- Relaxation factor for solution, default to one
-        scalar relaxationFactor_;
-
 
 public:
 
@@ -93,8 +89,8 @@ public:
             autoPtr,
             sixDoFRigidBodyMotionConstraint,
             dictionary,
-            (const dictionary& sDoFRBMCDict),
-            (sDoFRBMCDict)
+            (const word& name, const dictionary& sDoFRBMCDict),
+            (name, sDoFRBMCDict)
         );
 
 
@@ -103,6 +99,7 @@ public:
         //- Construct from the sDoFRBMCDict dictionary and Time
         sixDoFRigidBodyMotionConstraint
         (
+            const word& name,
             const dictionary& sDoFRBMCDict
         );
 
@@ -115,6 +112,7 @@ public:
         //- Select constructed from the sDoFRBMCDict dictionary and Time
         static autoPtr<sixDoFRigidBodyMotionConstraint> New
         (
+            const word& name,
             const dictionary& sDoFRBMCDict
         );
 
@@ -125,19 +123,17 @@ public:
 
     // Member Functions
 
-        //- Calculate the constraint position, force and moment.
-        //  Global reference frame vectors.  Returns boolean stating
-        //  whether the constraint been converged to tolerance.
-        virtual bool constrain
-        (
-            const sixDoFRigidBodyMotion& motion,
-            const vector& existingConstraintForce,
-            const vector& existingConstraintMoment,
-            scalar deltaT,
-            vector& constraintPosition,
-            vector& constraintForceIncrement,
-            vector& constraintMomentIncrement
-        ) const = 0;
+        //- Return the name
+        const word& name() const
+        {
+            return name_;
+        }
+
+        //- Apply and accumulate translational constraints
+        virtual void constrainTranslation(pointConstraint&) const = 0;
+
+        //- Apply and accumulate rotational constraints
+        virtual void constrainRotation(pointConstraint&) const = 0;
 
         //- Update properties from given dictionary
         virtual bool read(const dictionary& sDoFRBMCDict);
@@ -150,18 +146,6 @@ public:
                 return sDoFRBMCCoeffs_;
             }
 
-            //- Return access to the tolerance
-            inline scalar tolerance() const
-            {
-                return tolerance_;
-            }
-
-            //- Return access to the relaxationFactor
-            inline scalar relaxationFactor() const
-            {
-                return relaxationFactor_;
-            }
-
         //- Write
         virtual void write(Ostream&) const;
 };
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraintNew.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraintNew.C
similarity index 89%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraintNew.C
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraintNew.C
index fa74999aa5d8d3ec9dd785422758ade35fba4de7..b6f3e8fb1f195cee52efe82a3e65f2e993a6c592 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraintNew.C
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/constraints/sixDoFRigidBodyMotionConstraint/sixDoFRigidBodyMotionConstraintNew.C
@@ -28,16 +28,17 @@ License
 // * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * * //
 
 Foam::autoPtr<Foam::sixDoFRigidBodyMotionConstraint>
-Foam::sixDoFRigidBodyMotionConstraint::New(const dictionary& sDoFRBMCDict)
+Foam::sixDoFRigidBodyMotionConstraint::New
+(
+    const word& name,
+    const dictionary& sDoFRBMCDict
+)
 {
     const word constraintType
     (
         sDoFRBMCDict.lookup("sixDoFRigidBodyMotionConstraint")
     );
 
-    // Info<< "Selecting sixDoFRigidBodyMotionConstraint function "
-    //     << constraintType << endl;
-
     dictionaryConstructorTable::iterator cstrIter =
         dictionaryConstructorTablePtr_->find(constraintType);
 
@@ -56,7 +57,10 @@ Foam::sixDoFRigidBodyMotionConstraint::New(const dictionary& sDoFRBMCDict)
             << exit(FatalError);
     }
 
-    return autoPtr<sixDoFRigidBodyMotionConstraint>(cstrIter()(sDoFRBMCDict));
+    return autoPtr<sixDoFRigidBodyMotionConstraint>
+    (
+        cstrIter()(name, sDoFRBMCDict)
+    );
 }
 
 
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/linearAxialAngularSpring/linearAxialAngularSpring.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearAxialAngularSpring/linearAxialAngularSpring.C
similarity index 98%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/linearAxialAngularSpring/linearAxialAngularSpring.C
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearAxialAngularSpring/linearAxialAngularSpring.C
index 76805d60d47a8bf1772957292ca5a1a88ef9169a..504944bb29aff0272f399a3b7e1e1f19c1cdd815 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/linearAxialAngularSpring/linearAxialAngularSpring.C
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearAxialAngularSpring/linearAxialAngularSpring.C
@@ -51,10 +51,11 @@ namespace sixDoFRigidBodyMotionRestraints
 Foam::sixDoFRigidBodyMotionRestraints::linearAxialAngularSpring::
 linearAxialAngularSpring
 (
+    const word& name,
     const dictionary& sDoFRBMRDict
 )
 :
-    sixDoFRigidBodyMotionRestraint(sDoFRBMRDict),
+    sixDoFRigidBodyMotionRestraint(name, sDoFRBMRDict),
     refQ_(),
     axis_(),
     stiffness_(),
@@ -134,7 +135,6 @@ Foam::sixDoFRigidBodyMotionRestraints::linearAxialAngularSpring::restrain
     if (motion.report())
     {
         Info<< " angle " << theta*sign(a & axis_)
-            << " force " << restraintForce
             << " moment " << restraintMoment
             << endl;
     }
@@ -189,7 +189,6 @@ bool Foam::sixDoFRigidBodyMotionRestraints::linearAxialAngularSpring::read
     }
 
     sDoFRBMRCoeffs_.lookup("stiffness") >> stiffness_;
-
     sDoFRBMRCoeffs_.lookup("damping") >> damping_;
 
     return true;
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/linearAxialAngularSpring/linearAxialAngularSpring.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearAxialAngularSpring/linearAxialAngularSpring.H
similarity index 99%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/linearAxialAngularSpring/linearAxialAngularSpring.H
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearAxialAngularSpring/linearAxialAngularSpring.H
index d7f8c5e2805bc572d86f902dade04204c4efd074..4a30e30c65c14d576a49e57a93118057630370fb 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/linearAxialAngularSpring/linearAxialAngularSpring.H
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearAxialAngularSpring/linearAxialAngularSpring.H
@@ -81,6 +81,7 @@ public:
         //- Construct from components
         linearAxialAngularSpring
         (
+            const word& name,
             const dictionary& sDoFRBMRDict
         );
 
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearDamper/linearDamper.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearDamper/linearDamper.C
new file mode 100644
index 0000000000000000000000000000000000000000..792f265c2dedaaabce74bcf269de92c7a805a735
--- /dev/null
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearDamper/linearDamper.C
@@ -0,0 +1,113 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "linearDamper.H"
+#include "addToRunTimeSelectionTable.H"
+#include "sixDoFRigidBodyMotion.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace sixDoFRigidBodyMotionRestraints
+{
+    defineTypeNameAndDebug(linearDamper, 0);
+
+    addToRunTimeSelectionTable
+    (
+        sixDoFRigidBodyMotionRestraint,
+        linearDamper,
+        dictionary
+    );
+}
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::sixDoFRigidBodyMotionRestraints::linearDamper::linearDamper
+(
+    const word& name,
+    const dictionary& sDoFRBMRDict
+)
+:
+    sixDoFRigidBodyMotionRestraint(name, sDoFRBMRDict),
+    coeff_()
+{
+    read(sDoFRBMRDict);
+}
+
+
+// * * * * * * * * * * * * * * * * Destructors * * * * * * * * * * * * * * * //
+
+Foam::sixDoFRigidBodyMotionRestraints::linearDamper::~linearDamper()
+{}
+
+
+// * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
+
+void Foam::sixDoFRigidBodyMotionRestraints::linearDamper::restrain
+(
+    const sixDoFRigidBodyMotion& motion,
+    vector& restraintPosition,
+    vector& restraintForce,
+    vector& restraintMoment
+) const
+{
+    restraintForce = -coeff_*motion.v();
+    restraintMoment = vector::zero;
+
+    if (motion.report())
+    {
+        Info<< " force " << restraintForce
+            << endl;
+    }
+}
+
+
+bool Foam::sixDoFRigidBodyMotionRestraints::linearDamper::read
+(
+    const dictionary& sDoFRBMRDict
+)
+{
+    sixDoFRigidBodyMotionRestraint::read(sDoFRBMRDict);
+
+    sDoFRBMRCoeffs_.lookup("coeff") >> coeff_;
+
+    return true;
+}
+
+
+void Foam::sixDoFRigidBodyMotionRestraints::linearDamper::write
+(
+    Ostream& os
+) const
+{
+    os.writeKeyword("coeff")
+        << coeff_ << token::END_STATEMENT << nl;
+}
+
+
+// ************************************************************************* //
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearDamper/linearDamper.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearDamper/linearDamper.H
new file mode 100644
index 0000000000000000000000000000000000000000..0e991363fcef5e5faec7b09ad49ace028a123076
--- /dev/null
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearDamper/linearDamper.H
@@ -0,0 +1,121 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::sixDoFRigidBodyMotionRestraints::linearDamper
+
+Description
+    sixDoFRigidBodyMotionRestraints model.  Linear spring.
+
+SourceFiles
+    linearDamper.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef linearDamper_H
+#define linearDamper_H
+
+#include "sixDoFRigidBodyMotionRestraint.H"
+#include "point.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+namespace sixDoFRigidBodyMotionRestraints
+{
+
+/*---------------------------------------------------------------------------*\
+                          Class linearDamper Declaration
+\*---------------------------------------------------------------------------*/
+
+class linearDamper
+:
+    public sixDoFRigidBodyMotionRestraint
+{
+    // Private data
+
+        //- Damping coefficient (Ns/m)
+        scalar coeff_;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("linearDamper");
+
+
+    // Constructors
+
+        //- Construct from components
+        linearDamper
+        (
+            const word& name,
+            const dictionary& sDoFRBMRDict
+        );
+
+        //- Construct and return a clone
+        virtual autoPtr<sixDoFRigidBodyMotionRestraint> clone() const
+        {
+            return autoPtr<sixDoFRigidBodyMotionRestraint>
+            (
+                new linearDamper(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~linearDamper();
+
+
+    // Member Functions
+
+        //- Calculate the restraint position, force and moment.
+        //  Global reference frame vectors.
+        virtual void restrain
+        (
+            const sixDoFRigidBodyMotion& motion,
+            vector& restraintPosition,
+            vector& restraintForce,
+            vector& restraintMoment
+        ) const;
+
+        //- Update properties from given dictionary
+        virtual bool read(const dictionary& sDoFRBMRCoeff);
+
+        //- Write
+        virtual void write(Ostream&) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace solidBodyMotionFunctions
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/linearSpring/linearSpring.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearSpring/linearSpring.C
similarity index 96%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/linearSpring/linearSpring.C
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearSpring/linearSpring.C
index c6b1c10ca063592136c08861faa11022d9006566..a26660caf87871aad1e3379852820ee62ac0540f 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/linearSpring/linearSpring.C
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearSpring/linearSpring.C
@@ -49,10 +49,11 @@ namespace sixDoFRigidBodyMotionRestraints
 
 Foam::sixDoFRigidBodyMotionRestraints::linearSpring::linearSpring
 (
+    const word& name,
     const dictionary& sDoFRBMRDict
 )
 :
-    sixDoFRigidBodyMotionRestraint(sDoFRBMRDict),
+    sixDoFRigidBodyMotionRestraint(name, sDoFRBMRDict),
     anchor_(),
     refAttachmentPt_(),
     stiffness_(),
@@ -84,8 +85,6 @@ void Foam::sixDoFRigidBodyMotionRestraints::linearSpring::restrain
     vector r = restraintPosition - anchor_;
 
     scalar magR = mag(r);
-
-    // r is now the r unit vector
     r /= (magR + VSMALL);
 
     vector v = motion.currentVelocity(restraintPosition);
@@ -99,7 +98,6 @@ void Foam::sixDoFRigidBodyMotionRestraints::linearSpring::restrain
         Info<< " attachmentPt - anchor " << r*magR
             << " spring length " << magR
             << " force " << restraintForce
-            << " moment " << restraintMoment
             << endl;
     }
 }
@@ -113,13 +111,9 @@ bool Foam::sixDoFRigidBodyMotionRestraints::linearSpring::read
     sixDoFRigidBodyMotionRestraint::read(sDoFRBMRDict);
 
     sDoFRBMRCoeffs_.lookup("anchor") >> anchor_;
-
     sDoFRBMRCoeffs_.lookup("refAttachmentPt") >> refAttachmentPt_;
-
     sDoFRBMRCoeffs_.lookup("stiffness") >> stiffness_;
-
     sDoFRBMRCoeffs_.lookup("damping") >> damping_;
-
     sDoFRBMRCoeffs_.lookup("restLength") >> restLength_;
 
     return true;
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/linearSpring/linearSpring.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearSpring/linearSpring.H
similarity index 99%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/linearSpring/linearSpring.H
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearSpring/linearSpring.H
index c0610d974b39d9843580e78c81c473206e6370cd..dbd12372c3a928556a1ccdc6760be3b0194b925b 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/linearSpring/linearSpring.H
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/linearSpring/linearSpring.H
@@ -84,6 +84,7 @@ public:
         //- Construct from components
         linearSpring
         (
+            const word& name,
             const dictionary& sDoFRBMRDict
         );
 
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint.C
similarity index 83%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint.C
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint.C
index b06c5baf465f9262ec34ae7d69934c60c3584b38..6f53b504078fc27d5dc965a2115ccce5e7fa2065 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint.C
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint.C
@@ -29,9 +29,8 @@ License
 
 namespace Foam
 {
-defineTypeNameAndDebug(sixDoFRigidBodyMotionRestraint, 0);
-
-defineRunTimeSelectionTable(sixDoFRigidBodyMotionRestraint, dictionary);
+    defineTypeNameAndDebug(sixDoFRigidBodyMotionRestraint, 0);
+    defineRunTimeSelectionTable(sixDoFRigidBodyMotionRestraint, dictionary);
 }
 
 
@@ -39,17 +38,12 @@ defineRunTimeSelectionTable(sixDoFRigidBodyMotionRestraint, dictionary);
 
 Foam::sixDoFRigidBodyMotionRestraint::sixDoFRigidBodyMotionRestraint
 (
+    const word& name,
     const dictionary& sDoFRBMRDict
 )
 :
-    sDoFRBMRCoeffs_
-    (
-        sDoFRBMRDict.subDict
-        (
-            word(sDoFRBMRDict.lookup("sixDoFRigidBodyMotionRestraint"))
-          + "Coeffs"
-        )
-    )
+    name_(name),
+    sDoFRBMRCoeffs_(sDoFRBMRDict)
 {}
 
 
@@ -66,7 +60,7 @@ bool Foam::sixDoFRigidBodyMotionRestraint::read
     const dictionary& sDoFRBMRDict
 )
 {
-    sDoFRBMRCoeffs_ = sDoFRBMRDict.subDict(type() + "Coeffs");
+    sDoFRBMRCoeffs_ = sDoFRBMRDict;
 
     return true;
 }
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint.H
similarity index 92%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint.H
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint.H
index d8bdf1469a3d60b404ce8ab0f25157002ec1723a..41216a0c2ba55a29eff5f340dd5d9155e647ff36 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint.H
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint.H
@@ -69,6 +69,9 @@ protected:
 
     // Protected data
 
+        //- Name of the restraint
+        word name_;
+
         //- Restraint model specific coefficient dictionary
         dictionary sDoFRBMRCoeffs_;
 
@@ -86,8 +89,8 @@ public:
             autoPtr,
             sixDoFRigidBodyMotionRestraint,
             dictionary,
-            (const dictionary& sDoFRBMRDict),
-            (sDoFRBMRDict)
+            (const word& name, const dictionary& sDoFRBMRDict),
+            (name, sDoFRBMRDict)
         );
 
 
@@ -96,6 +99,7 @@ public:
         //- Construct from the sDoFRBMRDict dictionary and Time
         sixDoFRigidBodyMotionRestraint
         (
+            const word& name,
             const dictionary& sDoFRBMRDict
         );
 
@@ -108,6 +112,7 @@ public:
         //- Select constructed from the sDoFRBMRDict dictionary and Time
         static autoPtr<sixDoFRigidBodyMotionRestraint> New
         (
+            const word& name,
             const dictionary& sDoFRBMRDict
         );
 
@@ -118,6 +123,12 @@ public:
 
     // Member Functions
 
+        //- Return the name
+        const word& name() const
+        {
+            return name_;
+        }
+
         //- Calculate the restraint position, force and moment.
         //  Global reference frame vectors.
         virtual void restrain
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraintNew.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraintNew.C
similarity index 89%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraintNew.C
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraintNew.C
index 9361e0ab4df1c3b788435bb944d02d6ca50563da..1bb047a77d6d270f40a6fd121bbbee03c70099b5 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraintNew.C
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sixDoFRigidBodyMotionRestraint/sixDoFRigidBodyMotionRestraintNew.C
@@ -28,16 +28,17 @@ License
 // * * * * * * * * * * * * * * * * Selectors * * * * * * * * * * * * * * * * //
 
 Foam::autoPtr<Foam::sixDoFRigidBodyMotionRestraint>
-Foam::sixDoFRigidBodyMotionRestraint::New(const dictionary& sDoFRBMRDict)
+Foam::sixDoFRigidBodyMotionRestraint::New
+(
+    const word& name,
+    const dictionary& sDoFRBMRDict
+)
 {
     const word restraintType
     (
         sDoFRBMRDict.lookup("sixDoFRigidBodyMotionRestraint")
     );
 
-    // Info<< "Selecting sixDoFRigidBodyMotionRestraint function "
-    //     << restraintType << endl;
-
     dictionaryConstructorTable::iterator cstrIter =
         dictionaryConstructorTablePtr_->find(restraintType);
 
@@ -56,7 +57,10 @@ Foam::sixDoFRigidBodyMotionRestraint::New(const dictionary& sDoFRBMRDict)
             << exit(FatalError);
     }
 
-    return autoPtr<sixDoFRigidBodyMotionRestraint>(cstrIter()(sDoFRBMRDict));
+    return autoPtr<sixDoFRigidBodyMotionRestraint>
+    (
+        cstrIter()(name, sDoFRBMRDict)
+    );
 }
 
 
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sphericalAngularDamper/sphericalAngularDamper.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sphericalAngularDamper/sphericalAngularDamper.C
new file mode 100644
index 0000000000000000000000000000000000000000..fe5481689fd55aca58887295d8ac515c5bccf081
--- /dev/null
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sphericalAngularDamper/sphericalAngularDamper.C
@@ -0,0 +1,114 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "sphericalAngularDamper.H"
+#include "addToRunTimeSelectionTable.H"
+#include "sixDoFRigidBodyMotion.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace sixDoFRigidBodyMotionRestraints
+{
+    defineTypeNameAndDebug(sphericalAngularDamper, 0);
+
+    addToRunTimeSelectionTable
+    (
+        sixDoFRigidBodyMotionRestraint,
+        sphericalAngularDamper,
+        dictionary
+    );
+}
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::sixDoFRigidBodyMotionRestraints::sphericalAngularDamper::
+sphericalAngularDamper
+(
+    const word& name,
+    const dictionary& sDoFRBMRDict
+)
+:
+    sixDoFRigidBodyMotionRestraint(name, sDoFRBMRDict),
+    coeff_()
+{
+    read(sDoFRBMRDict);
+}
+
+
+// * * * * * * * * * * * * * * * * Destructors * * * * * * * * * * * * * * * //
+
+Foam::sixDoFRigidBodyMotionRestraints::sphericalAngularDamper::
+~sphericalAngularDamper()
+{}
+
+
+// * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
+
+void Foam::sixDoFRigidBodyMotionRestraints::sphericalAngularDamper::restrain
+(
+    const sixDoFRigidBodyMotion& motion,
+    vector& restraintPosition,
+    vector& restraintForce,
+    vector& restraintMoment
+) const
+{
+    restraintMoment = -coeff_*motion.omega();
+    restraintForce = vector::zero;
+
+    if (motion.report())
+    {
+        Info<< " moment " << restraintMoment
+            << endl;
+    }
+}
+
+
+bool Foam::sixDoFRigidBodyMotionRestraints::sphericalAngularDamper::read
+(
+    const dictionary& sDoFRBMRDict
+)
+{
+    sixDoFRigidBodyMotionRestraint::read(sDoFRBMRDict);
+
+    sDoFRBMRCoeffs_.lookup("coeff") >> coeff_;
+
+    return true;
+}
+
+
+void Foam::sixDoFRigidBodyMotionRestraints::sphericalAngularDamper::write
+(
+    Ostream& os
+) const
+{
+    os.writeKeyword("coeff") << coeff_ << token::END_STATEMENT << nl;
+}
+
+
+// ************************************************************************* //
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sphericalAngularDamper/sphericalAngularDamper.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sphericalAngularDamper/sphericalAngularDamper.H
new file mode 100644
index 0000000000000000000000000000000000000000..d917ae7d916ff0f205e5f769f4f063cb349b4312
--- /dev/null
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sphericalAngularDamper/sphericalAngularDamper.H
@@ -0,0 +1,120 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::sixDoFRigidBodyMotionRestraints::sphericalAngularDamper
+
+Description
+    sixDoFRigidBodyMotionRestraints model.  Spherical angular damper.
+
+SourceFiles
+    sphericalAngularDamper.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef sphericalAngularDamper_H
+#define sphericalAngularDamper_H
+
+#include "sixDoFRigidBodyMotionRestraint.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+namespace sixDoFRigidBodyMotionRestraints
+{
+
+/*---------------------------------------------------------------------------*\
+                   Class sphericalAngularDamper Declaration
+\*---------------------------------------------------------------------------*/
+
+class sphericalAngularDamper
+:
+    public sixDoFRigidBodyMotionRestraint
+{
+    // Private data
+
+        //- Damping coefficient (Nms/rad)
+        scalar coeff_;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("sphericalAngularDamper");
+
+
+    // Constructors
+
+        //- Construct from components
+        sphericalAngularDamper
+        (
+            const word& name,
+            const dictionary& sDoFRBMRDict
+        );
+
+        //- Construct and return a clone
+        virtual autoPtr<sixDoFRigidBodyMotionRestraint> clone() const
+        {
+            return autoPtr<sixDoFRigidBodyMotionRestraint>
+            (
+                new sphericalAngularDamper(*this)
+            );
+        }
+
+
+    //- Destructor
+    virtual ~sphericalAngularDamper();
+
+
+    // Member Functions
+
+        //- Calculate the restraint position, force and moment.
+        //  Global reference frame vectors.
+        virtual void restrain
+        (
+            const sixDoFRigidBodyMotion& motion,
+            vector& restraintPosition,
+            vector& restraintForce,
+            vector& restraintMoment
+        ) const;
+
+        //- Update properties from given dictionary
+        virtual bool read(const dictionary& sDoFRBMRCoeff);
+
+        //- Write
+        virtual void write(Ostream&) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace solidBodyMotionFunctions
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/sphericalAngularSpring/sphericalAngularSpring.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sphericalAngularSpring/sphericalAngularSpring.C
similarity index 95%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/sphericalAngularSpring/sphericalAngularSpring.C
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sphericalAngularSpring/sphericalAngularSpring.C
index dbb480b93aa692727e6ee5ca9b45cdc572809e0c..a0525a19e66c0ad0096afe1037af1adafe9464e3 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/sphericalAngularSpring/sphericalAngularSpring.C
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sphericalAngularSpring/sphericalAngularSpring.C
@@ -50,10 +50,11 @@ namespace sixDoFRigidBodyMotionRestraints
 Foam::sixDoFRigidBodyMotionRestraints::sphericalAngularSpring::
 sphericalAngularSpring
 (
+    const word& name,
     const dictionary& sDoFRBMRDict
 )
 :
-    sixDoFRigidBodyMotionRestraint(sDoFRBMRDict),
+    sixDoFRigidBodyMotionRestraint(name, sDoFRBMRDict),
     refQ_(),
     stiffness_(),
     damping_()
@@ -71,8 +72,7 @@ Foam::sixDoFRigidBodyMotionRestraints::sphericalAngularSpring::
 
 // * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
 
-void
-Foam::sixDoFRigidBodyMotionRestraints::sphericalAngularSpring::restrain
+void Foam::sixDoFRigidBodyMotionRestraints::sphericalAngularSpring::restrain
 (
     const sixDoFRigidBodyMotion& motion,
     vector& restraintPosition,
@@ -85,19 +85,15 @@ Foam::sixDoFRigidBodyMotionRestraints::sphericalAngularSpring::restrain
     for (direction cmpt=0; cmpt<vector::nComponents; cmpt++)
     {
         vector axis = vector::zero;
-
         axis[cmpt] = 1;
 
         vector refDir = vector::zero;
-
         refDir[(cmpt + 1) % 3] = 1;
 
         vector newDir = motion.orientation() & refDir;
 
         axis = (refQ_ & axis);
-
         refDir = (refQ_ & refDir);
-
         newDir -= (axis & newDir)*axis;
 
         restraintMoment += -stiffness_*(refDir ^ newDir);
@@ -113,8 +109,7 @@ Foam::sixDoFRigidBodyMotionRestraints::sphericalAngularSpring::restrain
 
     if (motion.report())
     {
-        Info<< " force " << restraintForce
-            << " moment " << restraintMoment
+        Info<< " moment " << restraintMoment
             << endl;
     }
 }
@@ -146,7 +141,6 @@ bool Foam::sixDoFRigidBodyMotionRestraints::sphericalAngularSpring::read
     }
 
     sDoFRBMRCoeffs_.lookup("stiffness") >> stiffness_;
-
     sDoFRBMRCoeffs_.lookup("damping") >> damping_;
 
     return true;
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/sphericalAngularSpring/sphericalAngularSpring.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sphericalAngularSpring/sphericalAngularSpring.H
similarity index 99%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/sphericalAngularSpring/sphericalAngularSpring.H
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sphericalAngularSpring/sphericalAngularSpring.H
index a36ef5d4ab104f3e1f2683184cd8496b73cb33f6..f1bfa784d371d1e78d0eb77890fd5c7736919da4 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/sphericalAngularSpring/sphericalAngularSpring.H
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/sphericalAngularSpring/sphericalAngularSpring.H
@@ -78,6 +78,7 @@ public:
         //- Construct from components
         sphericalAngularSpring
         (
+            const word& name,
             const dictionary& sDoFRBMRDict
         );
 
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/tabulatedAxialAngularSpring/tabulatedAxialAngularSpring.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/tabulatedAxialAngularSpring/tabulatedAxialAngularSpring.C
similarity index 98%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/tabulatedAxialAngularSpring/tabulatedAxialAngularSpring.C
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/tabulatedAxialAngularSpring/tabulatedAxialAngularSpring.C
index 252aa471f7958fab956c2887b1aa6e209e4537f0..1bf86e3b19c297a7773c25ec9c3c3b0e203c1111 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/tabulatedAxialAngularSpring/tabulatedAxialAngularSpring.C
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/tabulatedAxialAngularSpring/tabulatedAxialAngularSpring.C
@@ -52,10 +52,11 @@ namespace sixDoFRigidBodyMotionRestraints
 Foam::sixDoFRigidBodyMotionRestraints::tabulatedAxialAngularSpring::
 tabulatedAxialAngularSpring
 (
+    const word& name,
     const dictionary& sDoFRBMRDict
 )
 :
-    sixDoFRigidBodyMotionRestraint(sDoFRBMRDict),
+    sixDoFRigidBodyMotionRestraint(name, sDoFRBMRDict),
     refQ_(),
     axis_(),
     moment_(),
@@ -135,7 +136,6 @@ Foam::sixDoFRigidBodyMotionRestraints::tabulatedAxialAngularSpring::restrain
     if (motion.report())
     {
         Info<< " angle " << theta
-            << " force " << restraintForce
             << " moment " << restraintMoment
             << endl;
     }
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/tabulatedAxialAngularSpring/tabulatedAxialAngularSpring.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/tabulatedAxialAngularSpring/tabulatedAxialAngularSpring.H
similarity index 99%
rename from src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/tabulatedAxialAngularSpring/tabulatedAxialAngularSpring.H
rename to src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/tabulatedAxialAngularSpring/tabulatedAxialAngularSpring.H
index bb45f00d519361353833a4cb02574ccac7219757..bcd2c2c5b3f05362479d26028d2b698bcbe3aba9 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionRestraint/tabulatedAxialAngularSpring/tabulatedAxialAngularSpring.H
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/tabulatedAxialAngularSpring/tabulatedAxialAngularSpring.H
@@ -88,6 +88,7 @@ public:
         //- Construct from components
         tabulatedAxialAngularSpring
         (
+            const word& name,
             const dictionary& sDoFRBMRDict
         );
 
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion.C
index 6f002c5e2fec80cf2d5113c0de2b817a89db08b5..db88b739620712c0a6211dc9f6b0106aa37473ba 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion.C
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion.C
@@ -41,7 +41,7 @@ void Foam::sixDoFRigidBodyMotion::applyRestraints()
         {
             if (report_)
             {
-                Info<< "Restraint " << restraintNames_[rI] << ": ";
+                Info<< "Restraint " << restraints_[rI].name() << ": ";
             }
 
             // restraint position
@@ -65,101 +65,6 @@ void Foam::sixDoFRigidBodyMotion::applyRestraints()
 }
 
 
-void Foam::sixDoFRigidBodyMotion::applyConstraints(scalar deltaT)
-{
-    if (constraints_.empty())
-    {
-        return;
-    }
-
-    if (Pstream::master())
-    {
-        label iteration = 0;
-
-        bool allConverged = true;
-
-        // constraint force accumulator
-        vector cFA = vector::zero;
-
-        // constraint moment accumulator
-        vector cMA = vector::zero;
-
-        do
-        {
-            allConverged = true;
-
-            forAll(constraints_, cI)
-            {
-                if (sixDoFRigidBodyMotionConstraint::debug)
-                {
-                    Info<< "Constraint " << constraintNames_[cI] << ": ";
-                }
-
-                // constraint position
-                point cP = vector::zero;
-
-                // constraint force
-                vector cF = vector::zero;
-
-                // constraint moment
-                vector cM = vector::zero;
-
-                bool constraintConverged = constraints_[cI].constrain
-                (
-                    *this,
-                    cFA,
-                    cMA,
-                    deltaT,
-                    cP,
-                    cF,
-                    cM
-                );
-
-                allConverged = allConverged && constraintConverged;
-
-                // Accumulate constraint force
-                cFA += cF;
-
-                // Accumulate constraint moment
-                cMA += cM + ((cP - centreOfMass()) ^ cF);
-            }
-
-        } while(++iteration < maxConstraintIterations_ && !allConverged);
-
-        if (iteration >= maxConstraintIterations_)
-        {
-            FatalErrorIn
-            (
-                "Foam::sixDoFRigidBodyMotion::applyConstraints(scalar)"
-            )
-                << nl << "Maximum number of sixDoFRigidBodyMotion constraint "
-                << "iterations ("
-                << maxConstraintIterations_
-                << ") exceeded." << nl
-                << exit(FatalError);
-        }
-
-        Info<< "sixDoFRigidBodyMotion constraints converged in "
-            << iteration << " iterations" << endl;
-
-        if (report_)
-        {
-            Info<< "Constraint force: " << cFA << nl
-                << "Constraint moment: " << cMA
-                << endl;
-        }
-
-        // Add the constraint forces and moments to the motion state variables
-        a() += cFA/mass_;
-
-        // The moment of constraint forces has already been added
-        // during accumulation.  Moments are returned in global axes,
-        // transforming to body local
-        tau() += Q().T() & cMA;
-    }
-}
-
-
 // * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
 
 Foam::sixDoFRigidBodyMotion::sixDoFRigidBodyMotion()
@@ -167,10 +72,9 @@ Foam::sixDoFRigidBodyMotion::sixDoFRigidBodyMotion()
     motionState_(),
     motionState0_(),
     restraints_(),
-    restraintNames_(),
     constraints_(),
-    constraintNames_(),
-    maxConstraintIterations_(0),
+    tConstraints_(tensor::I),
+    rConstraints_(tensor::I),
     initialCentreOfMass_(vector::zero),
     initialQ_(I),
     momentOfInertia_(diagTensor::one*VSMALL),
@@ -209,10 +113,9 @@ Foam::sixDoFRigidBodyMotion::sixDoFRigidBodyMotion
     ),
     motionState0_(motionState_),
     restraints_(),
-    restraintNames_(),
     constraints_(),
-    constraintNames_(),
-    maxConstraintIterations_(0),
+    tConstraints_(tensor::I),
+    rConstraints_(tensor::I),
     initialCentreOfMass_(initialCentreOfMass),
     initialQ_(initialQ),
     momentOfInertia_(momentOfInertia),
@@ -232,10 +135,9 @@ Foam::sixDoFRigidBodyMotion::sixDoFRigidBodyMotion
     motionState_(stateDict),
     motionState0_(motionState_),
     restraints_(),
-    restraintNames_(),
     constraints_(),
-    constraintNames_(),
-    maxConstraintIterations_(0),
+    tConstraints_(tensor::I),
+    rConstraints_(tensor::I),
     initialCentreOfMass_
     (
         dict.lookupOrDefault
@@ -249,7 +151,7 @@ Foam::sixDoFRigidBodyMotion::sixDoFRigidBodyMotion
         dict.lookupOrDefault
         (
             "initialOrientation",
-            dict.lookupOrDefault("orientation", I)
+            dict.lookupOrDefault("orientation", tensor::I)
         )
     ),
     momentOfInertia_(dict.lookup("momentOfInertia")),
@@ -271,10 +173,7 @@ Foam::sixDoFRigidBodyMotion::sixDoFRigidBodyMotion
     motionState_(sDoFRBM.motionState_),
     motionState0_(sDoFRBM.motionState0_),
     restraints_(sDoFRBM.restraints_),
-    restraintNames_(sDoFRBM.restraintNames_),
     constraints_(sDoFRBM.constraints_),
-    constraintNames_(sDoFRBM.constraintNames_),
-    maxConstraintIterations_(sDoFRBM.maxConstraintIterations_),
     initialCentreOfMass_(sDoFRBM.initialCentreOfMass_),
     initialQ_(sDoFRBM.initialQ_),
     momentOfInertia_(sDoFRBM.momentOfInertia_),
@@ -306,29 +205,23 @@ void Foam::sixDoFRigidBodyMotion::addRestraints
 
         restraints_.setSize(restraintDict.size());
 
-        restraintNames_.setSize(restraintDict.size());
-
         forAllConstIter(IDLList<entry>, restraintDict, iter)
         {
             if (iter().isDict())
             {
-                // Info<< "Adding restraint: " << iter().keyword() << endl;
-
                 restraints_.set
                 (
-                    i,
-                    sixDoFRigidBodyMotionRestraint::New(iter().dict())
+                    i++,
+                    sixDoFRigidBodyMotionRestraint::New
+                    (
+                        iter().keyword(),
+                        iter().dict()
+                    )
                 );
-
-                restraintNames_[i] = iter().keyword();
-
-                i++;
             }
         }
 
         restraints_.setSize(i);
-
-        restraintNames_.setSize(i);
     }
 }
 
@@ -346,21 +239,25 @@ void Foam::sixDoFRigidBodyMotion::addConstraints
 
         constraints_.setSize(constraintDict.size());
 
-        constraintNames_.setSize(constraintDict.size());
+        pointConstraint pct;
+        pointConstraint pcr;
 
         forAllConstIter(IDLList<entry>, constraintDict, iter)
         {
             if (iter().isDict())
             {
-                // Info<< "Adding constraint: " << iter().keyword() << endl;
-
                 constraints_.set
                 (
                     i,
-                    sixDoFRigidBodyMotionConstraint::New(iter().dict())
+                    sixDoFRigidBodyMotionConstraint::New
+                    (
+                        iter().keyword(),
+                        iter().dict()
+                    )
                 );
 
-                constraintNames_[i] = iter().keyword();
+                constraints_[i].constrainTranslation(pct);
+                constraints_[i].constrainRotation(pcr);
 
                 i++;
             }
@@ -368,15 +265,11 @@ void Foam::sixDoFRigidBodyMotion::addConstraints
 
         constraints_.setSize(i);
 
-        constraintNames_.setSize(i);
+        tConstraints_ = pct.constraintTransformation();
+        rConstraints_ = pcr.constraintTransformation();
 
-        if (!constraints_.empty())
-        {
-            maxConstraintIterations_ = readLabel
-            (
-                constraintDict.lookup("maxIterations")
-            );
-        }
+        Info<< "Translational constraint tensor " << tConstraints_ << nl
+            << "Rotational constraint tensor " << rConstraints_ << endl;
     }
 }
 
@@ -392,8 +285,8 @@ void Foam::sixDoFRigidBodyMotion::updatePosition
 
     if (Pstream::master())
     {
-        v() = v0() + aDamp_*0.5*deltaT0*a();
-        pi() = pi0() + aDamp_*0.5*deltaT0*tau();
+        v() = tConstraints_ & aDamp_*(v0() + 0.5*deltaT0*a());
+        pi() = rConstraints_ & aDamp_*(pi0() + 0.5*deltaT0*tau());
 
         // Leapfrog move part
         centreOfMass() = centreOfMass0() + deltaT*v();
@@ -401,7 +294,7 @@ void Foam::sixDoFRigidBodyMotion::updatePosition
         // Leapfrog orientation adjustment
         Tuple2<tensor, vector> Qpi = rotate(Q0(), pi(), deltaT);
         Q() = Qpi.first();
-        pi() = Qpi.second();
+        pi() = rConstraints_ & Qpi.second();
     }
 
     Pstream::scatter(motionState_);
@@ -439,12 +332,9 @@ void Foam::sixDoFRigidBodyMotion::updateAcceleration
         }
         first = false;
 
-        // Apply constraints after relaxation
-        applyConstraints(deltaT);
-
         // Correct velocities
-        v() += aDamp_*0.5*deltaT*a();
-        pi() += aDamp_*0.5*deltaT*tau();
+        v() += tConstraints_ & aDamp_*0.5*deltaT*a();
+        pi() += rConstraints_ & aDamp_*0.5*deltaT*tau();
 
         if (report_)
         {
@@ -463,8 +353,8 @@ void Foam::sixDoFRigidBodyMotion::updateVelocity(scalar deltaT)
 
     if (Pstream::master())
     {
-        v() += aDamp_*0.5*deltaT*a();
-        pi() += aDamp_*0.5*deltaT*tau();
+        v() += tConstraints_ & aDamp_*0.5*deltaT*a();
+        pi() += rConstraints_ & aDamp_*0.5*deltaT*tau();
 
         if (report_)
         {
@@ -532,7 +422,10 @@ Foam::vector Foam::sixDoFRigidBodyMotion::predictedOrientation
     vector piTemp = pi() + deltaT*(tau() + (Q().T() & deltaMoment));
     Tuple2<tensor, vector> QpiTemp = rotate(Q0(), piTemp, deltaT);
 
-    return (QpiTemp.first() & initialQ_.T() & vInitial);
+    vector o(QpiTemp.first() & initialQ_.T() & vInitial);
+    o /= mag(o);
+
+    return o;
 }
 
 
@@ -564,8 +457,6 @@ Foam::tmp<Foam::pointField> Foam::sixDoFRigidBodyMotion::scaledPosition
     const scalarField& scale
 ) const
 {
-    Info<< "initialCentreOfMass " << initialCentreOfMass() << endl;
-
     // Calculate the transformation septerion from the initial state
     septernion s
     (
@@ -602,4 +493,22 @@ Foam::tmp<Foam::pointField> Foam::sixDoFRigidBodyMotion::scaledPosition
 }
 
 
+bool Foam::sixDoFRigidBodyMotion::read(const dictionary& dict)
+{
+    dict.lookup("momentOfInertia") >> momentOfInertia_;
+    dict.lookup("mass") >> mass_;
+    aRelax_ = dict.lookupOrDefault<scalar>("accelerationRelaxation", 1.0);
+    aDamp_ = dict.lookupOrDefault<scalar>("accelerationDamping", 1.0);
+    report_ = dict.lookupOrDefault<Switch>("report", false);
+
+    restraints_.clear();
+    addRestraints(dict);
+
+    constraints_.clear();
+    addConstraints(dict);
+
+    return true;
+}
+
+
 // ************************************************************************* //
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion.H
index 670004ba693e0eba489e2d7204ee1d6e8cd37b0b..c7b4bd7c30a8aeb512e4a13ca82b53ba1d304498 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion.H
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion.H
@@ -90,21 +90,17 @@ class sixDoFRigidBodyMotion
         //- Motion state data object for previous time-step
         sixDoFRigidBodyMotionState motionState0_;
 
-        //- Restraints on the motion
+        //- Motion restraints
         PtrList<sixDoFRigidBodyMotionRestraint> restraints_;
 
-        //- Names of the restraints
-        wordList restraintNames_;
-
-        //- Constaints on the motion
+        //- Motion constaints
         PtrList<sixDoFRigidBodyMotionConstraint> constraints_;
 
-        //- Names of the constraints
-        wordList constraintNames_;
+        //- Translational constraint tensor
+        tensor tConstraints_;
 
-        //- Maximum number of iterations allowed to attempt to obey
-        //  constraints
-        label maxConstraintIterations_;
+        //- Rotational constraint tensor
+        tensor rConstraints_;
 
         //- Centre of mass of initial state
         point initialCentreOfMass_;
@@ -155,9 +151,6 @@ class sixDoFRigidBodyMotion
         //- Apply the restraints to the object
         void applyRestraints();
 
-        //- Apply the constraints to the object
-        void applyConstraints(scalar deltaT);
-
 
         // Access functions retained as private because of the risk of
         // confusion over what is a body local frame vector and what is global
@@ -168,20 +161,10 @@ class sixDoFRigidBodyMotion
             inline const PtrList<sixDoFRigidBodyMotionRestraint>&
                 restraints() const;
 
-            //- Return access to the restraintNames
-            inline const wordList& restraintNames() const;
-
             //- Return access to the constraints
             inline const PtrList<sixDoFRigidBodyMotionConstraint>&
                 constraints() const;
 
-            //- Return access to the constraintNames
-            inline const wordList& constraintNames() const;
-
-            //- Return access to the maximum allowed number of
-            //  constraint iterations
-            inline label maxConstraintIterations() const;
-
             //- Return access to the initial centre of mass
             inline const point& initialCentreOfMass() const;
 
@@ -191,9 +174,6 @@ class sixDoFRigidBodyMotion
             //- Return access to the orientation
             inline const tensor& Q() const;
 
-            //- Return access to velocity
-            inline const vector& v() const;
-
             //- Return access to acceleration
             inline const vector& a() const;
 
@@ -373,8 +353,7 @@ public:
         //- Return the angular velocity in the global frame
         inline vector omega() const;
 
-        //- Return the velocity of a position given by the current
-        //  motion state
+        //- Return the velocity of a position
         inline point currentVelocity(const point& pt) const;
 
         //- Report the status of the motion
@@ -401,6 +380,9 @@ public:
             //- Return the report Switch
             inline bool report() const;
 
+            //- Return access to velocity
+            inline const vector& v() const;
+
 
         // Edit
 
@@ -421,6 +403,11 @@ public:
         void write(Ostream&) const;
 
 
+        //- Read coefficients dictionary and update system parameters,
+        //  constraints and restraints but not the current state
+        bool read(const dictionary& dict);
+
+
     // IOstream Operators
 
         friend Istream& operator>>(Istream&, sixDoFRigidBodyMotion&);
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedAxis/fixedAxis.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedAxis/fixedAxis.C
deleted file mode 100644
index 0e2737842535eba35bbd5a64b08e37c9a1a2b701..0000000000000000000000000000000000000000
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedAxis/fixedAxis.C
+++ /dev/null
@@ -1,187 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
-     \\/     M anipulation  |
--------------------------------------------------------------------------------
-License
-    This file is part of OpenFOAM.
-
-    OpenFOAM is free software: you can redistribute it and/or modify it
-    under the terms of the GNU General Public License as published by
-    the Free Software Foundation, either version 3 of the License, or
-    (at your option) any later version.
-
-    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
-    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
-    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
-    for more details.
-
-    You should have received a copy of the GNU General Public License
-    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
-
-\*---------------------------------------------------------------------------*/
-
-#include "fixedAxis.H"
-#include "addToRunTimeSelectionTable.H"
-#include "sixDoFRigidBodyMotion.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace sixDoFRigidBodyMotionConstraints
-{
-    defineTypeNameAndDebug(fixedAxis, 0);
-
-    addToRunTimeSelectionTable
-    (
-        sixDoFRigidBodyMotionConstraint,
-        fixedAxis,
-        dictionary
-    );
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::sixDoFRigidBodyMotionConstraints::fixedAxis::fixedAxis
-(
-    const dictionary& sDoFRBMCDict
-)
-:
-    sixDoFRigidBodyMotionConstraint(sDoFRBMCDict),
-    fixedAxis_()
-{
-    read(sDoFRBMCDict);
-}
-
-
-// * * * * * * * * * * * * * * * * Destructors * * * * * * * * * * * * * * * //
-
-Foam::sixDoFRigidBodyMotionConstraints::fixedAxis::~fixedAxis()
-{}
-
-
-// * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
-
-bool Foam::sixDoFRigidBodyMotionConstraints::fixedAxis::constrain
-(
-    const sixDoFRigidBodyMotion& motion,
-    const vector& existingConstraintForce,
-    const vector& existingConstraintMoment,
-    scalar deltaT,
-    vector& constraintPosition,
-    vector& constraintForceIncrement,
-    vector& constraintMomentIncrement
-) const
-{
-    constraintMomentIncrement = vector::zero;
-
-    vector predictedDir = motion.predictedOrientation
-    (
-        fixedAxis_,
-        existingConstraintMoment,
-        deltaT
-    );
-
-    scalar theta = acos(min(predictedDir & fixedAxis_, 1.0));
-
-    vector rotationAxis = fixedAxis_ ^ predictedDir;
-
-    scalar magRotationAxis = mag(rotationAxis);
-
-    if (magRotationAxis > VSMALL)
-    {
-        rotationAxis /= magRotationAxis;
-
-        const tensor& Q = motion.orientation();
-
-        // Transform rotationAxis to body local system
-        rotationAxis = Q.T() & rotationAxis;
-
-        constraintMomentIncrement =
-           -relaxationFactor_
-           *(motion.momentOfInertia() & rotationAxis)
-           *theta/sqr(deltaT);
-
-        // Transform moment increment to global system
-        constraintMomentIncrement = Q & constraintMomentIncrement;
-
-        // Remove any moment that is around the fixedAxis_
-        constraintMomentIncrement -=
-            (constraintMomentIncrement & fixedAxis_)*fixedAxis_;
-    }
-
-    constraintPosition = motion.centreOfMass();
-
-    constraintForceIncrement = vector::zero;
-
-    bool converged(mag(theta) < tolerance_);
-
-    if (sixDoFRigidBodyMotionConstraint::debug)
-    {
-        Info<< " angle " << theta
-            << " force " << constraintForceIncrement
-            << " moment " << constraintMomentIncrement;
-
-        if (converged)
-        {
-            Info<< " converged";
-        }
-        else
-        {
-            Info<< " not converged";
-        }
-
-        Info<< endl;
-    }
-
-    return converged;
-}
-
-
-bool Foam::sixDoFRigidBodyMotionConstraints::fixedAxis::read
-(
-    const dictionary& sDoFRBMCDict
-)
-{
-    sixDoFRigidBodyMotionConstraint::read(sDoFRBMCDict);
-
-    sDoFRBMCCoeffs_.lookup("axis") >> fixedAxis_;
-
-    scalar magFixedAxis(mag(fixedAxis_));
-
-    if (magFixedAxis > VSMALL)
-    {
-        fixedAxis_ /= magFixedAxis;
-    }
-    else
-    {
-        FatalErrorIn
-        (
-            "Foam::sixDoFRigidBodyMotionConstraints::fixedAxis::read"
-            "("
-                "const dictionary& sDoFRBMCDict"
-            ")"
-        )
-            << "axis has zero length"
-            << abort(FatalError);
-    }
-
-    return true;
-}
-
-
-void Foam::sixDoFRigidBodyMotionConstraints::fixedAxis::write
-(
-    Ostream& os
-) const
-{
-    os.writeKeyword("axis")
-        << fixedAxis_ << token::END_STATEMENT << nl;
-}
-
-// ************************************************************************* //
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedOrientation/fixedOrientation.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedOrientation/fixedOrientation.C
deleted file mode 100644
index c66bdbb3623383e897bf77d359c2ca110314030e..0000000000000000000000000000000000000000
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedOrientation/fixedOrientation.C
+++ /dev/null
@@ -1,186 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
-     \\/     M anipulation  |
--------------------------------------------------------------------------------
-License
-    This file is part of OpenFOAM.
-
-    OpenFOAM is free software: you can redistribute it and/or modify it
-    under the terms of the GNU General Public License as published by
-    the Free Software Foundation, either version 3 of the License, or
-    (at your option) any later version.
-
-    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
-    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
-    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
-    for more details.
-
-    You should have received a copy of the GNU General Public License
-    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
-
-\*---------------------------------------------------------------------------*/
-
-#include "fixedOrientation.H"
-#include "addToRunTimeSelectionTable.H"
-#include "sixDoFRigidBodyMotion.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace sixDoFRigidBodyMotionConstraints
-{
-    defineTypeNameAndDebug(fixedOrientation, 0);
-
-    addToRunTimeSelectionTable
-    (
-        sixDoFRigidBodyMotionConstraint,
-        fixedOrientation,
-        dictionary
-    );
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::sixDoFRigidBodyMotionConstraints::fixedOrientation::fixedOrientation
-(
-    const dictionary& sDoFRBMCDict
-)
-:
-    sixDoFRigidBodyMotionConstraint(sDoFRBMCDict)
-{
-    read(sDoFRBMCDict);
-}
-
-
-// * * * * * * * * * * * * * * * * Destructors * * * * * * * * * * * * * * * //
-
-Foam::sixDoFRigidBodyMotionConstraints::fixedOrientation::~fixedOrientation()
-{}
-
-
-// * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
-
-bool Foam::sixDoFRigidBodyMotionConstraints::fixedOrientation::constrain
-(
-    const sixDoFRigidBodyMotion& motion,
-    const vector& existingConstraintForce,
-    const vector& existingConstraintMoment,
-    scalar deltaT,
-    vector& constraintPosition,
-    vector& constraintForceIncrement,
-    vector& constraintMomentIncrement
-) const
-{
-    constraintMomentIncrement = vector::zero;
-
-    scalar maxTheta = -SMALL;
-
-    for (direction cmpt=0; cmpt<vector::nComponents; cmpt++)
-    {
-        vector axis = vector::zero;
-
-        axis[cmpt] = 1;
-
-        vector refDir = vector::zero;
-
-        refDir[(cmpt + 1) % 3] = 1;
-
-        vector predictedDir = motion.predictedOrientation
-        (
-            refDir,
-            existingConstraintMoment,
-            deltaT
-        );
-
-        // Removing any axis component from predictedDir
-        predictedDir -= (axis & predictedDir)*axis;
-
-        scalar theta = GREAT;
-
-        scalar magPredictedDir = mag(predictedDir);
-
-        if (magPredictedDir > VSMALL)
-        {
-            predictedDir /= magPredictedDir;
-
-            theta = acos(min(predictedDir & refDir, 1.0));
-
-            // Recalculating axis to give correct sign to angle
-            axis = (refDir ^ predictedDir);
-
-            scalar magAxis = mag(axis);
-
-            if (magAxis > VSMALL)
-            {
-                axis /= magAxis;
-            }
-            else
-            {
-                axis = vector::zero;
-            }
-        }
-
-        if (theta > maxTheta)
-        {
-            maxTheta = theta;
-        }
-
-        constraintMomentIncrement +=
-           -relaxationFactor_
-           *theta*axis
-           *motion.momentOfInertia()[cmpt]/sqr(deltaT);
-    }
-
-    constraintPosition = motion.centreOfMass();
-
-    constraintForceIncrement = vector::zero;
-
-    bool converged(mag(maxTheta) < tolerance_);
-
-    if (sixDoFRigidBodyMotionConstraint::debug)
-    {
-        Info<< " max angle " << maxTheta
-            << " force " << constraintForceIncrement
-            << " moment " << constraintMomentIncrement;
-
-        if (converged)
-        {
-            Info<< " converged";
-        }
-        else
-        {
-            Info<< " not converged";
-        }
-
-        Info<< endl;
-    }
-
-    return converged;
-}
-
-
-bool Foam::sixDoFRigidBodyMotionConstraints::fixedOrientation::read
-(
-    const dictionary& sDoFRBMCDict
-)
-{
-    sixDoFRigidBodyMotionConstraint::read(sDoFRBMCDict);
-
-    return true;
-}
-
-
-void Foam::sixDoFRigidBodyMotionConstraints::fixedOrientation::write
-(
-    Ostream& os
-) const
-{
-}
-
-// ************************************************************************* //
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedPlane/fixedPlane.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedPlane/fixedPlane.C
deleted file mode 100644
index 263694ee3f2ee1a8c449055844088dcb1632e88f..0000000000000000000000000000000000000000
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedPlane/fixedPlane.C
+++ /dev/null
@@ -1,161 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
-     \\/     M anipulation  |
--------------------------------------------------------------------------------
-License
-    This file is part of OpenFOAM.
-
-    OpenFOAM is free software: you can redistribute it and/or modify it
-    under the terms of the GNU General Public License as published by
-    the Free Software Foundation, either version 3 of the License, or
-    (at your option) any later version.
-
-    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
-    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
-    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
-    for more details.
-
-    You should have received a copy of the GNU General Public License
-    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
-
-\*---------------------------------------------------------------------------*/
-
-#include "fixedPlane.H"
-#include "addToRunTimeSelectionTable.H"
-#include "sixDoFRigidBodyMotion.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace sixDoFRigidBodyMotionConstraints
-{
-    defineTypeNameAndDebug(fixedPlane, 0);
-
-    addToRunTimeSelectionTable
-    (
-        sixDoFRigidBodyMotionConstraint,
-        fixedPlane,
-        dictionary
-    );
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::sixDoFRigidBodyMotionConstraints::fixedPlane::fixedPlane
-(
-    const dictionary& sDoFRBMCDict
-)
-:
-    sixDoFRigidBodyMotionConstraint(sDoFRBMCDict),
-    fixedPlane_(vector::one)
-{
-    read(sDoFRBMCDict);
-}
-
-
-// * * * * * * * * * * * * * * * * Destructors * * * * * * * * * * * * * * * //
-
-Foam::sixDoFRigidBodyMotionConstraints::fixedPlane::~fixedPlane()
-{}
-
-
-// * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
-
-bool Foam::sixDoFRigidBodyMotionConstraints::fixedPlane::constrain
-(
-    const sixDoFRigidBodyMotion& motion,
-    const vector& existingConstraintForce,
-    const vector& existingConstraintMoment,
-    scalar deltaT,
-    vector& constraintPosition,
-    vector& constraintForceIncrement,
-    vector& constraintMomentIncrement
-) const
-{
-    const point& refPt = fixedPlane_.refPoint();
-
-    const vector& n = fixedPlane_.normal();
-
-    point predictedPosition = motion.predictedPosition
-    (
-        refPt,
-        existingConstraintForce,
-        existingConstraintMoment,
-        deltaT
-    );
-
-    constraintPosition = motion.currentPosition(refPt);
-
-    // Info<< "current position " << constraintPosition << nl
-    //     << "next predictedPosition " << predictedPosition
-    //     << endl;
-
-    vector error = ((predictedPosition - refPt) & n)*n;
-
-    // Info<< "error " << error << endl;
-
-    constraintForceIncrement =
-        -relaxationFactor_*error*motion.mass()/sqr(deltaT);
-
-    constraintMomentIncrement = vector::zero;
-
-    bool converged(mag(error) < tolerance_);
-
-    if (sixDoFRigidBodyMotionConstraint::debug)
-    {
-        Info<< " error " << error
-            << " force " << constraintForceIncrement
-            << " moment " << constraintMomentIncrement;
-
-        if (converged)
-        {
-            Info<< " converged";
-        }
-        else
-        {
-            Info<< " not converged";
-        }
-
-        Info<< endl;
-    }
-
-    return converged;
-}
-
-
-bool Foam::sixDoFRigidBodyMotionConstraints::fixedPlane::read
-(
-    const dictionary& sDoFRBMCDict
-)
-{
-    sixDoFRigidBodyMotionConstraint::read(sDoFRBMCDict);
-
-    point refPt = sDoFRBMCCoeffs_.lookup("refPoint");
-
-    vector normal = sDoFRBMCCoeffs_.lookup("normal");
-
-    fixedPlane_ = plane(refPt, normal);
-
-    return true;
-}
-
-
-void Foam::sixDoFRigidBodyMotionConstraints::fixedPlane::write
-(
-    Ostream& os
-) const
-{
-    os.writeKeyword("refPoint")
-        << fixedPlane_.refPoint() << token::END_STATEMENT << nl;
-
-    os.writeKeyword("normal")
-        << fixedPlane_.normal() << token::END_STATEMENT << nl;
-}
-
-// ************************************************************************* //
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedPoint/fixedPoint.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedPoint/fixedPoint.C
deleted file mode 100644
index 084334868dbee3ab2cc9a8f20b9625e29c22666c..0000000000000000000000000000000000000000
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionConstraint/fixedPoint/fixedPoint.C
+++ /dev/null
@@ -1,163 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
-     \\/     M anipulation  |
--------------------------------------------------------------------------------
-License
-    This file is part of OpenFOAM.
-
-    OpenFOAM is free software: you can redistribute it and/or modify it
-    under the terms of the GNU General Public License as published by
-    the Free Software Foundation, either version 3 of the License, or
-    (at your option) any later version.
-
-    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
-    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
-    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
-    for more details.
-
-    You should have received a copy of the GNU General Public License
-    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
-
-\*---------------------------------------------------------------------------*/
-
-#include "fixedPoint.H"
-#include "addToRunTimeSelectionTable.H"
-#include "sixDoFRigidBodyMotion.H"
-
-// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
-
-namespace Foam
-{
-namespace sixDoFRigidBodyMotionConstraints
-{
-    defineTypeNameAndDebug(fixedPoint, 0);
-
-    addToRunTimeSelectionTable
-    (
-        sixDoFRigidBodyMotionConstraint,
-        fixedPoint,
-        dictionary
-    );
-}
-}
-
-
-// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
-
-Foam::sixDoFRigidBodyMotionConstraints::fixedPoint::fixedPoint
-(
-    const dictionary& sDoFRBMCDict
-)
-:
-    sixDoFRigidBodyMotionConstraint(sDoFRBMCDict),
-    fixedPoint_()
-{
-    read(sDoFRBMCDict);
-}
-
-
-// * * * * * * * * * * * * * * * * Destructors * * * * * * * * * * * * * * * //
-
-Foam::sixDoFRigidBodyMotionConstraints::fixedPoint::~fixedPoint()
-{}
-
-
-// * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * * //
-
-bool Foam::sixDoFRigidBodyMotionConstraints::fixedPoint::constrain
-(
-    const sixDoFRigidBodyMotion& motion,
-    const vector& existingConstraintForce,
-    const vector& existingConstraintMoment,
-    scalar deltaT,
-    vector& constraintPosition,
-    vector& constraintForceIncrement,
-    vector& constraintMomentIncrement
-) const
-{
-    point predictedPosition = motion.predictedPosition
-    (
-        fixedPoint_,
-        existingConstraintForce,
-        existingConstraintMoment,
-        deltaT
-    );
-
-    constraintPosition = motion.currentPosition(fixedPoint_);
-
-    // Info<< "current position " << constraintPosition << nl
-    //     << "next predictedPosition " << predictedPosition
-    //     << endl;
-
-    vector error = predictedPosition - fixedPoint_;
-
-    // Info<< "error " << error << endl;
-
-    // Correction force derived from Lagrange multiplier:
-    //     G = -lambda*grad(sigma)
-    // where
-    //     sigma = mag(error) = 0
-    // so
-    //     grad(sigma) = error/mag(error)
-    // Solving for lambda using the SHAKE methodology gives
-    //     lambda = mass*mag(error)/sqr(deltaT)
-    // This is only strictly applicable (i.e. will converge in one
-    // iteration) to constraints at the centre of mass.  Everything
-    // else will need to iterate, and may need under-relaxed to be
-    // stable.
-
-    constraintForceIncrement =
-        -relaxationFactor_*error*motion.mass()/sqr(deltaT);
-
-    constraintMomentIncrement = vector::zero;
-
-    bool converged(mag(error) < tolerance_);
-
-    if (sixDoFRigidBodyMotionConstraint::debug)
-    {
-        Info<< " error " << error
-            << " force " << constraintForceIncrement
-            << " moment " << constraintMomentIncrement;
-
-        if (converged)
-        {
-            Info<< " converged";
-        }
-        else
-        {
-            Info<< " not converged";
-        }
-
-        Info<< endl;
-    }
-
-    return converged;
-}
-
-
-bool Foam::sixDoFRigidBodyMotionConstraints::fixedPoint::read
-(
-    const dictionary& sDoFRBMCDict
-)
-{
-    sixDoFRigidBodyMotionConstraint::read(sDoFRBMCDict);
-
-    sDoFRBMCCoeffs_.lookup("fixedPoint") >> fixedPoint_;
-
-    return true;
-}
-
-
-void Foam::sixDoFRigidBodyMotionConstraints::fixedPoint::write
-(
-    Ostream& os
-) const
-{
-    os.writeKeyword("fixedPoint")
-        << fixedPoint_ << token::END_STATEMENT << nl;
-}
-
-// ************************************************************************* //
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionI.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionI.H
index f70ba68ced1cc79c20dcc26b009130d4734201b4..3186ca2fa1251f190104e49dcbfbb368e59df12d 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionI.H
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionI.H
@@ -111,12 +111,6 @@ Foam::sixDoFRigidBodyMotion::restraints() const
 }
 
 
-inline const Foam::wordList& Foam::sixDoFRigidBodyMotion::restraintNames() const
-{
-    return restraintNames_;
-}
-
-
 inline const Foam::PtrList<Foam::sixDoFRigidBodyMotionConstraint>&
 Foam::sixDoFRigidBodyMotion::constraints() const
 {
@@ -124,19 +118,6 @@ Foam::sixDoFRigidBodyMotion::constraints() const
 }
 
 
-inline const Foam::wordList&
-Foam::sixDoFRigidBodyMotion::constraintNames() const
-{
-    return constraintNames_;
-}
-
-
-inline Foam::label Foam::sixDoFRigidBodyMotion::maxConstraintIterations() const
-{
-    return maxConstraintIterations_;
-}
-
-
 inline const Foam::point&
 Foam::sixDoFRigidBodyMotion::initialCentreOfMass() const
 {
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionIO.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionIO.C
index 99bdba3ef022f370b9c096ab7482db75b2ede074..11670ba6231ceb64a269a506cbbaaac5d2397d35 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionIO.C
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionIO.C
@@ -54,7 +54,7 @@ void Foam::sixDoFRigidBodyMotion::write(Ostream& os) const
         {
             word restraintType = restraints_[rI].type();
 
-            os  << indent << restraintNames_[rI] << nl
+            os  << indent << restraints_[rI].name() << nl
                 << indent << token::BEGIN_BLOCK << incrIndent << endl;
 
             os.writeKeyword("sixDoFRigidBodyMotionRestraint")
@@ -79,14 +79,11 @@ void Foam::sixDoFRigidBodyMotion::write(Ostream& os) const
         os  << indent << "constraints" << nl
             << indent << token::BEGIN_BLOCK << incrIndent << nl;
 
-        os.writeKeyword("maxIterations")
-            << maxConstraintIterations_ << token::END_STATEMENT << nl;
-
         forAll(constraints_, rI)
         {
             word constraintType = constraints_[rI].type();
 
-            os  << indent << constraintNames_[rI] << nl
+            os  << indent << constraints_[rI].name() << nl
                 << indent << token::BEGIN_BLOCK << incrIndent << endl;
 
             os.writeKeyword("sixDoFRigidBodyMotionConstraint")
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionState.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionState.C
index e92274c09844e8ce80bae96fcf7e462136851f45..0e9aada9d015dc2e64b743974e1f8ea566837440 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionState.C
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionState.C
@@ -63,7 +63,7 @@ Foam::sixDoFRigidBodyMotionState::sixDoFRigidBodyMotionState
 )
 :
     centreOfMass_(dict.lookup("centreOfMass")),
-    Q_(dict.lookupOrDefault("orientation", tensor(I))),
+    Q_(dict.lookupOrDefault("orientation", tensor::I)),
     v_(dict.lookupOrDefault("velocity", vector::zero)),
     a_(dict.lookupOrDefault("acceleration", vector::zero)),
     pi_(dict.lookupOrDefault("angularMomentum", vector::zero)),
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionSolver/sixDoFRigidBodyMotionSolver.C b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionSolver/sixDoFRigidBodyMotionSolver.C
index 2e208340428d4b3207d8f0bf6efe83c9b601a8aa..58d2b8caddf51619d74549288ac067cae10a9180 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionSolver/sixDoFRigidBodyMotionSolver.C
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionSolver/sixDoFRigidBodyMotionSolver.C
@@ -220,7 +220,10 @@ void Foam::sixDoFRigidBodyMotionSolver::solve()
         motion_.scaledPosition(points0(), scale_) - points0();
 
     // Displacement has changed. Update boundary conditions
-    pointConstraints::New(mesh()).constrainDisplacement(pointDisplacement_);
+    pointConstraints::New
+    (
+        pointDisplacement_.mesh()
+    ).constrainDisplacement(pointDisplacement_);
 }
 
 
@@ -250,4 +253,19 @@ bool Foam::sixDoFRigidBodyMotionSolver::writeObject
 }
 
 
+bool Foam::sixDoFRigidBodyMotionSolver::read()
+{
+    if (displacementMotionSolver::read())
+    {
+        motion_.read(coeffDict());
+
+        return true;
+    }
+    else
+    {
+        return false;
+    }
+}
+
+
 // ************************************************************************* //
diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionSolver/sixDoFRigidBodyMotionSolver.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionSolver/sixDoFRigidBodyMotionSolver.H
index 410745d96cddebc793cdd1f8d07c632866d246fb..4f4e1ca31c5a80e14eaee7ab06f00cbfa8ae8685 100644
--- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionSolver/sixDoFRigidBodyMotionSolver.H
+++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotionSolver/sixDoFRigidBodyMotionSolver.H
@@ -133,6 +133,9 @@ public:
             IOstream::versionNumber ver,
             IOstream::compressionType cmp
         ) const;
+
+        //- Read dynamicMeshDict dictionary
+        virtual bool read();
 };
 
 
diff --git a/src/topoChangerFvMesh/rawTopoChangerFvMesh/rawTopoChangerFvMesh.C b/src/topoChangerFvMesh/rawTopoChangerFvMesh/rawTopoChangerFvMesh.C
index 2234cf1808953bf540ead9c6e12a860a8b6f05b2..a2fb50dc40306689ca42b44ad7bf92cc1079539c 100644
--- a/src/topoChangerFvMesh/rawTopoChangerFvMesh/rawTopoChangerFvMesh.C
+++ b/src/topoChangerFvMesh/rawTopoChangerFvMesh/rawTopoChangerFvMesh.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-2013 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -65,6 +65,12 @@ bool Foam::rawTopoChangerFvMesh::update()
     // Do mesh changes (use inflation - put new points in topoChangeMap)
     Info<< "rawTopoChangerFvMesh : Checking for topology changes..."
         << endl;
+
+    // Mesh not moved/changed yet
+    moving(false);
+    topoChanging(false);
+
+    // Do any topology changes. Sets topoChanging (through polyTopoChange)
     autoPtr<mapPolyMesh> topoChangeMap = topoChanger_.changeMesh(true);
 
     bool hasChanged = topoChangeMap.valid();
@@ -170,8 +176,6 @@ bool Foam::rawTopoChangerFvMesh::update()
         //    << " no topology changes..." << endl;
     }
 
-    changing(hasChanged);
-
     return hasChanged;
 }
 
diff --git a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/p_rgh b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/p_rgh
index e0461769d0df7f7d60f7dbff5bbbe256f9691ac8..d95b85f7ba74d9fbf5e5c929e0cb613c485cd5f6 100755
--- a/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/p_rgh
+++ b/tutorials/combustion/fireFoam/les/flameSpreadWaterSuppressionPanel/0/p_rgh
@@ -21,12 +21,6 @@ internalField   uniform 101325;
 
 boundaryField
 {
-    wall
-    {
-        type            fixedFluxPressure;
-        value           $internalField;
-    }
-
     outlet
     {
         type            fixedFluxPressure;
diff --git a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/T b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/T
index 561ca236be3bbed252ef63b29c24063a3bea4c6b..76e54ad382f43e125823fe484246da452995bbbd 100644
--- a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/T
+++ b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/T
@@ -29,7 +29,7 @@ boundaryField
     {
         type            zeroGradient;
     }
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/U b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/U
index e9b532f37361e311feb19f07d7173d8ed7d6b847..47440fb13c2895cc6e5b111aa82c272220c6b014 100644
--- a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/U
+++ b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/U
@@ -30,7 +30,7 @@ boundaryField
         type            fixedValue;
         value           uniform (0 0 0);
     }
-    wall
+    walls
     {
         type            fixedValue;
         value           uniform (0 0 0);
diff --git a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/alphat b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/alphat
index dc2104f83c5ce3f90987cad077de403fcd15988e..33ecb425e27cb111e2666f0fa5ffc8d0172cfbcc 100644
--- a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/alphat
+++ b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/alphat
@@ -31,7 +31,7 @@ boundaryField
         type            compressible::alphatWallFunction;
         value           uniform 0;
     }
-    wall
+    walls
     {
         type            compressible::alphatWallFunction;
         value           uniform 0;
diff --git a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/epsilon b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/epsilon
index e4dccfe57777d09934d55a61d67f94e2917585f0..c6f28faeeaf202cd08718d61816fa127f2566cbd 100644
--- a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/epsilon
+++ b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/epsilon
@@ -31,7 +31,7 @@ boundaryField
         type            compressible::epsilonWallFunction;
         value           uniform 200;
     }
-    wall
+    walls
     {
         type            compressible::epsilonWallFunction;
         value           uniform 200;
diff --git a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/k b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/k
index 655a91bb45e3aa597a5280c13d1a8262524a0fbd..b92ab42afed9c7b45cf4466d159470b451dc2f00 100644
--- a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/k
+++ b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/k
@@ -31,7 +31,7 @@ boundaryField
         type            compressible::kqRWallFunction;
         value           uniform 1;
     }
-    wall
+    walls
     {
         type            compressible::kqRWallFunction;
         value           uniform 1;
diff --git a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/mut b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/mut
index 0cea2db2d2e1aa076b70254b0e314b9959cc0d78..6f779fd4165aa85ac33ecc18e39ae1a43a7dda6d 100644
--- a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/mut
+++ b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/mut
@@ -31,7 +31,7 @@ boundaryField
         type            mutkWallFunction;
         value           uniform 0;
     }
-    wall
+    walls
     {
         type            mutkWallFunction;
         value           uniform 0;
diff --git a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/p b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/p
index 21db04d6109a0348229d019cb3a13d728044c86d..e3bdb75a7e4f8064978713b2ae58d4fde47f382e 100644
--- a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/p
+++ b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/0/p
@@ -28,7 +28,7 @@ boundaryField
     {
         type            zeroGradient;
     }
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/constant/polyMesh/blockMeshDict.m4 b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/constant/polyMesh/blockMeshDict.m4
index 79da11e10ac8f655aa16fc6287c9496875d8672f..09a4670392e59bae438f7ff2a8f5e7a3c1a66a6a 100644
--- a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/constant/polyMesh/blockMeshDict.m4
+++ b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/constant/polyMesh/blockMeshDict.m4
@@ -126,7 +126,7 @@ patches
     backQuad(poro1, out1, out2, poro2)
     )
 
-    wall wall
+    wall walls
     (
     // inlet block
     quad2D(in1, join1)
diff --git a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/constant/polyMesh/boundary b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/constant/polyMesh/boundary
index 0abd1608aba0dcb6aa66c9488133a3c4b51c7588..7a2d7d0e5e3c3269c847b329574269a0fa857aac 100644
--- a/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/constant/polyMesh/boundary
+++ b/tutorials/compressible/rhoLTSPimpleFoam/angledDuct/constant/polyMesh/boundary
@@ -20,24 +20,28 @@ FoamFile
     front
     {
         type            wall;
+        inGroups        1(wall);
         nFaces          700;
         startFace       63400;
     }
     back
     {
         type            wall;
+        inGroups        1(wall);
         nFaces          700;
         startFace       64100;
     }
-    wall
+    walls
     {
         type            wall;
+        inGroups        1(wall);
         nFaces          1400;
         startFace       64800;
     }
     porosityWall
     {
         type            wall;
+        inGroups        1(wall);
         nFaces          1600;
         startFace       66200;
     }
diff --git a/tutorials/compressible/rhoPimpleDyMFoam/annularThermalMixer/constant/polyMesh/boundary b/tutorials/compressible/rhoPimpleDyMFoam/annularThermalMixer/constant/polyMesh/boundary
deleted file mode 100644
index 2d2096ddc33a88afe285ab661e56c9d239439a44..0000000000000000000000000000000000000000
--- a/tutorials/compressible/rhoPimpleDyMFoam/annularThermalMixer/constant/polyMesh/boundary
+++ /dev/null
@@ -1,112 +0,0 @@
-/*--------------------------------*- C++ -*----------------------------------*\
-| =========                 |                                                 |
-| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  dev                                   |
-|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
-|    \\/     M anipulation  |                                                 |
-\*---------------------------------------------------------------------------*/
-FoamFile
-{
-    version     2.0;
-    format      ascii;
-    class       polyBoundaryMesh;
-    location    "constant/polyMesh";
-    object      boundary;
-}
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-12
-(
-    innerInlet
-    {
-        type            patch;
-        inGroups        1(inlet);
-        nFaces          544;
-        startFace       245836;
-    }
-    outerInlet
-    {
-        type            patch;
-        inGroups        1(inlet);
-        nFaces          1404;
-        startFace       246380;
-    }
-    innerOutlet
-    {
-        type            patch;
-        inGroups        1(outlet);
-        nFaces          544;
-        startFace       247784;
-    }
-    outerOutlet
-    {
-        type            patch;
-        inGroups        1(outlet);
-        nFaces          1404;
-        startFace       248328;
-    }
-    rotorBlades
-    {
-        type            wall;
-        inGroups        1(movingWalls);
-        nFaces          540;
-        startFace       249732;
-    }
-    rotorBlades_slave
-    {
-        type            wall;
-        inGroups        1(movingWalls);
-        nFaces          540;
-        startFace       250272;
-    }
-    shaft
-    {
-        type            wall;
-        inGroups        1(movingWalls);
-        nFaces          1044;
-        startFace       250812;
-    }
-    statorBlades
-    {
-        type            wall;
-        inGroups        1(staticWalls);
-        nFaces          2128;
-        startFace       251856;
-    }
-    statorBlades_slave
-    {
-        type            wall;
-        inGroups        1(staticWalls);
-        nFaces          2128;
-        startFace       253984;
-    }
-    wall
-    {
-        type            wall;
-        inGroups        1(staticWalls);
-        nFaces          6165;
-        startFace       256112;
-    }
-    AMI1
-    {
-        type            cyclicAMI;
-        inGroups        1(cyclicAMI);
-        nFaces          10944;
-        startFace       262277;
-        matchTolerance  0.0001;
-        transform       noOrdering;
-        neighbourPatch  AMI2;
-    }
-    AMI2
-    {
-        type            cyclicAMI;
-        inGroups        1(cyclicAMI);
-        nFaces          10944;
-        startFace       273221;
-        matchTolerance  0.0001;
-        transform       noOrdering;
-        neighbourPatch  AMI1;
-    }
-)
-
-// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimpleDyMFoam/annularThermalMixer/system/snappyHexMeshDict b/tutorials/compressible/rhoPimpleDyMFoam/annularThermalMixer/system/snappyHexMeshDict
index ea372875da17f872cc4c8e5d5e4c334926798b1c..f211a4aebbf33d648e6a26b4cf36909df506b035 100644
--- a/tutorials/compressible/rhoPimpleDyMFoam/annularThermalMixer/system/snappyHexMeshDict
+++ b/tutorials/compressible/rhoPimpleDyMFoam/annularThermalMixer/system/snappyHexMeshDict
@@ -71,7 +71,7 @@ geometry
     wall.obj
     {
         type        triSurfaceMesh;
-        name        wall;
+        name        walls;
     }
 };
 
@@ -191,7 +191,7 @@ castellatedMeshControls
             faceType baffle;
         }
 
-        wall
+        walls
         {
             level       (1 1);
             patchInfo
diff --git a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/T b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/T
index 561ca236be3bbed252ef63b29c24063a3bea4c6b..76e54ad382f43e125823fe484246da452995bbbd 100644
--- a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/T
+++ b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/T
@@ -29,7 +29,7 @@ boundaryField
     {
         type            zeroGradient;
     }
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/U b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/U
index 713bdebe4a1ae6141aed1c1b8764f065fc4f5663..454300ab0e9135a7b1dc0f8cbe1587a4d6db5ec2 100644
--- a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/U
+++ b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/U
@@ -30,7 +30,7 @@ boundaryField
         type            fixedValue;
         value           uniform (0 0 0);
     }
-    wall
+    walls
     {
         type            fixedValue;
         value           uniform (0 0 0);
diff --git a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/alphat b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/alphat
index dc2104f83c5ce3f90987cad077de403fcd15988e..33ecb425e27cb111e2666f0fa5ffc8d0172cfbcc 100644
--- a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/alphat
+++ b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/alphat
@@ -31,7 +31,7 @@ boundaryField
         type            compressible::alphatWallFunction;
         value           uniform 0;
     }
-    wall
+    walls
     {
         type            compressible::alphatWallFunction;
         value           uniform 0;
diff --git a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/epsilon b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/epsilon
index e4dccfe57777d09934d55a61d67f94e2917585f0..c6f28faeeaf202cd08718d61816fa127f2566cbd 100644
--- a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/epsilon
+++ b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/epsilon
@@ -31,7 +31,7 @@ boundaryField
         type            compressible::epsilonWallFunction;
         value           uniform 200;
     }
-    wall
+    walls
     {
         type            compressible::epsilonWallFunction;
         value           uniform 200;
diff --git a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/k b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/k
index 655a91bb45e3aa597a5280c13d1a8262524a0fbd..b92ab42afed9c7b45cf4466d159470b451dc2f00 100644
--- a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/k
+++ b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/k
@@ -31,7 +31,7 @@ boundaryField
         type            compressible::kqRWallFunction;
         value           uniform 1;
     }
-    wall
+    walls
     {
         type            compressible::kqRWallFunction;
         value           uniform 1;
diff --git a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/mut b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/mut
index 0cea2db2d2e1aa076b70254b0e314b9959cc0d78..6f779fd4165aa85ac33ecc18e39ae1a43a7dda6d 100644
--- a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/mut
+++ b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/mut
@@ -31,7 +31,7 @@ boundaryField
         type            mutkWallFunction;
         value           uniform 0;
     }
-    wall
+    walls
     {
         type            mutkWallFunction;
         value           uniform 0;
diff --git a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/p b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/p
index 21db04d6109a0348229d019cb3a13d728044c86d..e3bdb75a7e4f8064978713b2ae58d4fde47f382e 100644
--- a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/p
+++ b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/0/p
@@ -28,7 +28,7 @@ boundaryField
     {
         type            zeroGradient;
     }
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/constant/polyMesh/blockMeshDict.m4 b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/constant/polyMesh/blockMeshDict.m4
index 2e865a7856a7ac268e22302a7b752184d8bc0ba7..ce48c80996201835928337f288825089fcb610a9 100644
--- a/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/constant/polyMesh/blockMeshDict.m4
+++ b/tutorials/compressible/rhoPimpleFoam/ras/angledDuct/constant/polyMesh/blockMeshDict.m4
@@ -134,7 +134,7 @@ boundary
         );
     }
 
-    wall
+    walls
     {
         type wall;
         faces
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/U b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/U
index 1105ba84b0d3d45703447c25e8255a293531b6c5..590ae2411e1f9b8cd3d51ca85154c20be0780665 100644
--- a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/U
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/U
@@ -30,7 +30,7 @@ boundaryField
         type            fixedValue;
         value           uniform (0 0 0);
     }
-    wall
+    walls
     {
         type            fixedValue;
         value           uniform (0 0 0);
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/alphat b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/alphat
index dc2104f83c5ce3f90987cad077de403fcd15988e..33ecb425e27cb111e2666f0fa5ffc8d0172cfbcc 100644
--- a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/alphat
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/alphat
@@ -31,7 +31,7 @@ boundaryField
         type            compressible::alphatWallFunction;
         value           uniform 0;
     }
-    wall
+    walls
     {
         type            compressible::alphatWallFunction;
         value           uniform 0;
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/epsilon b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/epsilon
index e4dccfe57777d09934d55a61d67f94e2917585f0..c6f28faeeaf202cd08718d61816fa127f2566cbd 100644
--- a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/epsilon
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/epsilon
@@ -31,7 +31,7 @@ boundaryField
         type            compressible::epsilonWallFunction;
         value           uniform 200;
     }
-    wall
+    walls
     {
         type            compressible::epsilonWallFunction;
         value           uniform 200;
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/k b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/k
index 655a91bb45e3aa597a5280c13d1a8262524a0fbd..b92ab42afed9c7b45cf4466d159470b451dc2f00 100644
--- a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/k
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/k
@@ -31,7 +31,7 @@ boundaryField
         type            compressible::kqRWallFunction;
         value           uniform 1;
     }
-    wall
+    walls
     {
         type            compressible::kqRWallFunction;
         value           uniform 1;
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/mut b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/mut
index 0cea2db2d2e1aa076b70254b0e314b9959cc0d78..6f779fd4165aa85ac33ecc18e39ae1a43a7dda6d 100644
--- a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/mut
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/mut
@@ -31,7 +31,7 @@ boundaryField
         type            mutkWallFunction;
         value           uniform 0;
     }
-    wall
+    walls
     {
         type            mutkWallFunction;
         value           uniform 0;
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/p b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/p
index 21db04d6109a0348229d019cb3a13d728044c86d..e3bdb75a7e4f8064978713b2ae58d4fde47f382e 100644
--- a/tutorials/compressible/rhoPimplecFoam/angledDuct/0/p
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/0/p
@@ -28,7 +28,7 @@ boundaryField
     {
         type            zeroGradient;
     }
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/polyMesh/blockMeshDict.m4 b/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/polyMesh/blockMeshDict.m4
index 2e865a7856a7ac268e22302a7b752184d8bc0ba7..ce48c80996201835928337f288825089fcb610a9 100644
--- a/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/polyMesh/blockMeshDict.m4
+++ b/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/polyMesh/blockMeshDict.m4
@@ -134,7 +134,7 @@ boundary
         );
     }
 
-    wall
+    walls
     {
         type wall;
         faces
diff --git a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/T b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/T
index 561ca236be3bbed252ef63b29c24063a3bea4c6b..76e54ad382f43e125823fe484246da452995bbbd 100644
--- a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/T
+++ b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/T
@@ -29,7 +29,7 @@ boundaryField
     {
         type            zeroGradient;
     }
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/U b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/U
index 20e25d12a8c318b8b0532714ad2919ed4068fe7c..e121b9c3c157f21d94a780f473154c71cf8d6449 100644
--- a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/U
+++ b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/U
@@ -30,7 +30,7 @@ boundaryField
         type            fixedValue;
         value           uniform (0 0 0);
     }
-    wall
+    walls
     {
         type            fixedValue;
         value           uniform (0 0 0);
diff --git a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/alphat b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/alphat
index dc2104f83c5ce3f90987cad077de403fcd15988e..33ecb425e27cb111e2666f0fa5ffc8d0172cfbcc 100644
--- a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/alphat
+++ b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/alphat
@@ -31,7 +31,7 @@ boundaryField
         type            compressible::alphatWallFunction;
         value           uniform 0;
     }
-    wall
+    walls
     {
         type            compressible::alphatWallFunction;
         value           uniform 0;
diff --git a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/epsilon b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/epsilon
index 7588e13063f38c366c8ffde4243960a54be45481..12c9b362e351103e30b05972cde2500ebdd1db6a 100644
--- a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/epsilon
+++ b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/epsilon
@@ -33,7 +33,7 @@ boundaryField
         value           uniform 200;
     }
 
-    wall
+    walls
     {
         type            compressible::epsilonWallFunction;
         value           uniform 200;
diff --git a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/k b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/k
index 85df9b83c3bce148f8c7ac811acd0cf59387505a..3dbe46f030c7483050fa5023e9cb4716939c57a8 100644
--- a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/k
+++ b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/k
@@ -33,7 +33,7 @@ boundaryField
         value           uniform 1;
     }
 
-    wall
+    walls
     {
         type            compressible::kqRWallFunction;
         value           uniform 1;
diff --git a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/mut b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/mut
index 2ba718d5b53378d89430ecd57f631fb03f833a0f..a01a5a0eed8c3424ca6025f067546ab01055b02e 100644
--- a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/mut
+++ b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/mut
@@ -33,7 +33,7 @@ boundaryField
         value           uniform 0;
     }
 
-    wall
+    walls
     {
         type            mutkWallFunction;
         value           uniform 0;
diff --git a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/p b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/p
index 21db04d6109a0348229d019cb3a13d728044c86d..e3bdb75a7e4f8064978713b2ae58d4fde47f382e 100644
--- a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/p
+++ b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/0/p
@@ -28,7 +28,7 @@ boundaryField
     {
         type            zeroGradient;
     }
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/constant/polyMesh/blockMeshDict.m4 b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/constant/polyMesh/blockMeshDict.m4
index 79da11e10ac8f655aa16fc6287c9496875d8672f..09a4670392e59bae438f7ff2a8f5e7a3c1a66a6a 100644
--- a/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/constant/polyMesh/blockMeshDict.m4
+++ b/tutorials/compressible/rhoPorousSimpleFoam/angledDuctImplicit/constant/polyMesh/blockMeshDict.m4
@@ -126,7 +126,7 @@ patches
     backQuad(poro1, out1, out2, poro2)
     )
 
-    wall wall
+    wall walls
     (
     // inlet block
     quad2D(in1, join1)
diff --git a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/T b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/T
index 561ca236be3bbed252ef63b29c24063a3bea4c6b..76e54ad382f43e125823fe484246da452995bbbd 100644
--- a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/T
+++ b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/T
@@ -29,7 +29,7 @@ boundaryField
     {
         type            zeroGradient;
     }
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/U b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/U
index 20e25d12a8c318b8b0532714ad2919ed4068fe7c..e121b9c3c157f21d94a780f473154c71cf8d6449 100644
--- a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/U
+++ b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/U
@@ -30,7 +30,7 @@ boundaryField
         type            fixedValue;
         value           uniform (0 0 0);
     }
-    wall
+    walls
     {
         type            fixedValue;
         value           uniform (0 0 0);
diff --git a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/alphat b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/alphat
index dc2104f83c5ce3f90987cad077de403fcd15988e..33ecb425e27cb111e2666f0fa5ffc8d0172cfbcc 100644
--- a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/alphat
+++ b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/alphat
@@ -31,7 +31,7 @@ boundaryField
         type            compressible::alphatWallFunction;
         value           uniform 0;
     }
-    wall
+    walls
     {
         type            compressible::alphatWallFunction;
         value           uniform 0;
diff --git a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/epsilon b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/epsilon
index 7588e13063f38c366c8ffde4243960a54be45481..12c9b362e351103e30b05972cde2500ebdd1db6a 100644
--- a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/epsilon
+++ b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/epsilon
@@ -33,7 +33,7 @@ boundaryField
         value           uniform 200;
     }
 
-    wall
+    walls
     {
         type            compressible::epsilonWallFunction;
         value           uniform 200;
diff --git a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/k b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/k
index 85df9b83c3bce148f8c7ac811acd0cf59387505a..3dbe46f030c7483050fa5023e9cb4716939c57a8 100644
--- a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/k
+++ b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/k
@@ -33,7 +33,7 @@ boundaryField
         value           uniform 1;
     }
 
-    wall
+    walls
     {
         type            compressible::kqRWallFunction;
         value           uniform 1;
diff --git a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/mut b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/mut
index 2ba718d5b53378d89430ecd57f631fb03f833a0f..a01a5a0eed8c3424ca6025f067546ab01055b02e 100644
--- a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/mut
+++ b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/mut
@@ -33,7 +33,7 @@ boundaryField
         value           uniform 0;
     }
 
-    wall
+    walls
     {
         type            mutkWallFunction;
         value           uniform 0;
diff --git a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/p b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/p
index 21db04d6109a0348229d019cb3a13d728044c86d..e3bdb75a7e4f8064978713b2ae58d4fde47f382e 100644
--- a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/p
+++ b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/0/p
@@ -28,7 +28,7 @@ boundaryField
     {
         type            zeroGradient;
     }
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/constant/polyMesh/blockMeshDict.m4 b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/constant/polyMesh/blockMeshDict.m4
index 79da11e10ac8f655aa16fc6287c9496875d8672f..09a4670392e59bae438f7ff2a8f5e7a3c1a66a6a 100644
--- a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/constant/polyMesh/blockMeshDict.m4
+++ b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/constant/polyMesh/blockMeshDict.m4
@@ -126,7 +126,7 @@ patches
     backQuad(poro1, out1, out2, poro2)
     )
 
-    wall wall
+    wall walls
     (
     // inlet block
     quad2D(in1, join1)
diff --git a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/constant/polyMesh/boundary b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/constant/polyMesh/boundary
index 0abd1608aba0dcb6aa66c9488133a3c4b51c7588..76e163242f2a76e34b8b5ca9f1aee9844f006eaf 100644
--- a/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/constant/polyMesh/boundary
+++ b/tutorials/compressible/rhoSimpleFoam/angledDuctExplicitFixedCoeff/constant/polyMesh/boundary
@@ -29,7 +29,7 @@ FoamFile
         nFaces          700;
         startFace       64100;
     }
-    wall
+    walls
     {
         type            wall;
         nFaces          1400;
diff --git a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/constant/polyMesh/blockMeshDict b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/constant/polyMesh/blockMeshDict
index c854ce532d428bb89c9389ccb5b1a3085f262077..265f4083449402e40055f6285e9d4eeefe3d0b4b 100644
--- a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/constant/polyMesh/blockMeshDict
+++ b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/constant/polyMesh/blockMeshDict
@@ -79,7 +79,6 @@ boundary
     ground
     {
         type        wall;
-        inGroups    (wall);
         faces
         (
             (0 3 2 1)
diff --git a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/system/snappyHexMeshDict b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/system/snappyHexMeshDict
index a6e206d5256b2bd365ca802844aaedffd1c81b50..ff6504711bb70b4fd89b02689dba4f4ca27ce9f1 100644
--- a/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/system/snappyHexMeshDict
+++ b/tutorials/heatTransfer/buoyantBoussinesqSimpleFoam/iglooWithFridges/system/snappyHexMeshDict
@@ -168,7 +168,6 @@ castellatedMeshControls
             patchInfo
             {
                 type        wall;
-                inGroups    (wall);
             }
         }
 
@@ -182,7 +181,6 @@ castellatedMeshControls
             patchInfo
             {
                 type        wall;
-                inGroups    (wall);
             }
         }
     }
diff --git a/tutorials/incompressible/icoFoam/Allclean b/tutorials/incompressible/icoFoam/Allclean
index 79a05d40a4b01355307a450fa5b39582e451f17e..587ffb1d53f8fe03b1b964f9b053221d33aa41e8 100755
--- a/tutorials/incompressible/icoFoam/Allclean
+++ b/tutorials/incompressible/icoFoam/Allclean
@@ -30,4 +30,7 @@ do
     removeCase $caseName
 done
 
+
+(cd elbow && ./Allclean)
+
 # ----------------------------------------------------------------- end-of-file
diff --git a/tutorials/incompressible/icoFoam/Allrun b/tutorials/incompressible/icoFoam/Allrun
index 44d04afe47a2beb8649653f22a7705084e1b40ff..acdcaabaee310f6886471d32f403bac2474ce20c 100755
--- a/tutorials/incompressible/icoFoam/Allrun
+++ b/tutorials/incompressible/icoFoam/Allrun
@@ -18,12 +18,6 @@ runMapFieldsConsistent()
     mapFieldsNew $1 -case $2 -sourceTime latestTime -consistent > $2/log.mapFields 2>&1
 }
 
-runFluentMeshToFoam()
-{
-    echo "fluentMeshToFoam: converting mesh $2"
-    fluentMeshToFoam $2 -case $1 > $1/log.fluentMeshToFoam 2>&1
-}
-
 copySolutionDirs()
 {
     echo "Copying $2/0* directory to $1"
@@ -95,16 +89,8 @@ do
     ( cd $caseName && runApplication `getApplication` )
 done
 
-# elbow case for testing Fluent-FOAM conversion tools
 
-runFluentMeshToFoam elbow elbow/elbow.msh
-
-(
-    cd elbow || exit
-
-    runApplication `getApplication`
-    runApplication foamMeshToFluent
-    runApplication foamDataToFluent
-)
+# elbow case for testing Fluent-FOAM conversion tools
+(cd elbow && ./Allrun)
 
 # ----------------------------------------------------------------- end-of-file
diff --git a/tutorials/incompressible/icoFoam/elbow/Allclean b/tutorials/incompressible/icoFoam/elbow/Allclean
new file mode 100755
index 0000000000000000000000000000000000000000..02a68a6b17bb4d336d4bc1afe3b50977eb14c0d4
--- /dev/null
+++ b/tutorials/incompressible/icoFoam/elbow/Allclean
@@ -0,0 +1,11 @@
+#!/bin/sh
+cd ${0%/*} || exit 1    # run from this directory
+
+# Source tutorial clean functions
+. $WM_PROJECT_DIR/bin/tools/CleanFunctions
+
+rm -f constant/polyMesh/boundary
+rm -rf fluentInterface
+cleanCase
+
+# ----------------------------------------------------------------- end-of-file
diff --git a/tutorials/incompressible/icoFoam/elbow/Allrun b/tutorials/incompressible/icoFoam/elbow/Allrun
new file mode 100755
index 0000000000000000000000000000000000000000..07a1ffac39d3ac66ae533ba8562068790259dcda
--- /dev/null
+++ b/tutorials/incompressible/icoFoam/elbow/Allrun
@@ -0,0 +1,15 @@
+#!/bin/sh
+cd ${0%/*} || exit 1    # run from this directory
+
+# Source tutorial run functions
+. $WM_PROJECT_DIR/bin/tools/RunFunctions
+
+# Get application directory
+application=`getApplication`
+
+runApplication fluentMeshToFoam elbow.msh
+runApplication "$application"
+runApplication foamMeshToFluent
+runApplication foamDataToFluent
+
+# ----------------------------------------------------------------- end-of-file
diff --git a/tutorials/incompressible/pimpleDyMFoam/wingMotion/wingMotion2D_pimpleDyMFoam/0.org/pointDisplacement b/tutorials/incompressible/pimpleDyMFoam/wingMotion/wingMotion2D_pimpleDyMFoam/0.org/pointDisplacement
index 7063b7a063710d0479dc652b46a886a7e65a9ba5..f517452a80530a2a95962a08f3df092a62723cc0 100644
--- a/tutorials/incompressible/pimpleDyMFoam/wingMotion/wingMotion2D_pimpleDyMFoam/0.org/pointDisplacement
+++ b/tutorials/incompressible/pimpleDyMFoam/wingMotion/wingMotion2D_pimpleDyMFoam/0.org/pointDisplacement
@@ -45,27 +45,21 @@ boundaryField
         {
             maxIterations   500;
 
-            fixedLine1
+            yLine
             {
-                sixDoFRigidBodyMotionConstraint fixedLine;
+                sixDoFRigidBodyMotionConstraint line;
                 tolerance        1e-9;
                 relaxationFactor 0.7;
-                fixedLineCoeffs
-                {
-                    refPoint      (0.25 0.007 0.125);
-                    direction     (0 1 0);
-                }
+                refPoint      (0.25 0.007 0.125);
+                direction     (0 1 0);
             }
 
-            fixedAxis1
+            zAxis
             {
-                sixDoFRigidBodyMotionConstraint fixedAxis;
+                sixDoFRigidBodyMotionConstraint axis;
                 tolerance       1e-06;
                 relaxationFactor 0.7;
-                fixedAxisCoeffs
-                {
-                    axis            ( 0 0 1 );
-                }
+                axis            (0 0 1);
             }
         }
         restraints
@@ -73,27 +67,19 @@ boundaryField
             verticalSpring
             {
                 sixDoFRigidBodyMotionRestraint linearSpring;
-
-                linearSpringCoeffs
-                {
-                    anchor          (0.25 0.007 0.125);
-                    refAttachmentPt (0.25 0.007 0.125);
-                    stiffness       4000;
-                    damping         2;
-                    restLength      0;
-                }
+                anchor          (0.25 0.007 0.125);
+                refAttachmentPt (0.25 0.007 0.125);
+                stiffness       4000;
+                damping         2;
+                restLength      0;
             }
             axialSpring
             {
                 sixDoFRigidBodyMotionRestraint linearAxialAngularSpring;
-
-                linearAxialAngularSpringCoeffs
-                {
-                    axis            (0 0 1);
-                    stiffness       700;
-                    damping         0.5;
-                    referenceOrientation $orientation;
-                }
+                axis            (0 0 1);
+                stiffness       700;
+                damping         0.5;
+                referenceOrientation $orientation;
             }
         }
         value           uniform (0 0 0);
@@ -109,11 +95,11 @@ boundaryField
         type            empty;
     }
 
-     ".*"
-     {
-         type            fixedValue;
-         value           uniform (0 0 0);
-     }
+    ".*"
+    {
+        type            fixedValue;
+        value           uniform (0 0 0);
+    }
 }
 
 
diff --git a/tutorials/incompressible/pimpleDyMFoam/wingMotion/wingMotion2D_pimpleDyMFoam/constant/dynamicMeshDict b/tutorials/incompressible/pimpleDyMFoam/wingMotion/wingMotion2D_pimpleDyMFoam/constant/dynamicMeshDict
index 4fad53756a4d1f21464878a4a8856c72de76d64d..82d0874bde90543ffcf993278f47def91518deb9 100644
--- a/tutorials/incompressible/pimpleDyMFoam/wingMotion/wingMotion2D_pimpleDyMFoam/constant/dynamicMeshDict
+++ b/tutorials/incompressible/pimpleDyMFoam/wingMotion/wingMotion2D_pimpleDyMFoam/constant/dynamicMeshDict
@@ -16,7 +16,7 @@ FoamFile
 
 dynamicFvMesh      dynamicMotionSolverFvMesh;
 
-motionSolverLibs ("libfvMotionSolvers.so");
+motionSolverLibs ("libfvMotionSolvers.so" "libsixDoFRigidBodyMotion.so");
 
 solver            displacementLaplacian;
 
diff --git a/tutorials/incompressible/pimpleDyMFoam/wingMotion/wingMotion2D_pimpleDyMFoam/constant/polyMesh/boundary b/tutorials/incompressible/pimpleDyMFoam/wingMotion/wingMotion2D_pimpleDyMFoam/constant/polyMesh/boundary
index d49af660efa6681a0a87e6ae900ba22907594978..927a3109ec4df3a179ef73e50f75ddf6d9fd122c 100644
--- a/tutorials/incompressible/pimpleDyMFoam/wingMotion/wingMotion2D_pimpleDyMFoam/constant/polyMesh/boundary
+++ b/tutorials/incompressible/pimpleDyMFoam/wingMotion/wingMotion2D_pimpleDyMFoam/constant/polyMesh/boundary
@@ -21,37 +21,40 @@ FoamFile
     {
         type            patch;
         nFaces          72;
-        startFace       25168;
+        startFace       22911;
     }
     inlet
     {
         type            patch;
         nFaces          40;
-        startFace       25240;
+        startFace       22983;
     }
     outlet
     {
         type            patch;
         nFaces          62;
-        startFace       25280;
+        startFace       23023;
     }
     front
     {
         type            empty;
-        nFaces          12559;
-        startFace       25342;
+        inGroups        1(empty);
+        nFaces          11431;
+        startFace       23085;
     }
     back
     {
         type            empty;
-        nFaces          12559;
-        startFace       37901;
+        inGroups        1(empty);
+        nFaces          11431;
+        startFace       34516;
     }
     wing
     {
         type            wall;
+        inGroups        1(wall);
         nFaces          378;
-        startFace       50460;
+        startFace       45947;
     }
 )
 
diff --git a/tutorials/incompressible/pimpleDyMFoam/wingMotion/wingMotion2D_simpleFoam/constant/polyMesh/boundary b/tutorials/incompressible/pimpleDyMFoam/wingMotion/wingMotion2D_simpleFoam/constant/polyMesh/boundary
index d49af660efa6681a0a87e6ae900ba22907594978..927a3109ec4df3a179ef73e50f75ddf6d9fd122c 100644
--- a/tutorials/incompressible/pimpleDyMFoam/wingMotion/wingMotion2D_simpleFoam/constant/polyMesh/boundary
+++ b/tutorials/incompressible/pimpleDyMFoam/wingMotion/wingMotion2D_simpleFoam/constant/polyMesh/boundary
@@ -21,37 +21,40 @@ FoamFile
     {
         type            patch;
         nFaces          72;
-        startFace       25168;
+        startFace       22911;
     }
     inlet
     {
         type            patch;
         nFaces          40;
-        startFace       25240;
+        startFace       22983;
     }
     outlet
     {
         type            patch;
         nFaces          62;
-        startFace       25280;
+        startFace       23023;
     }
     front
     {
         type            empty;
-        nFaces          12559;
-        startFace       25342;
+        inGroups        1(empty);
+        nFaces          11431;
+        startFace       23085;
     }
     back
     {
         type            empty;
-        nFaces          12559;
-        startFace       37901;
+        inGroups        1(empty);
+        nFaces          11431;
+        startFace       34516;
     }
     wing
     {
         type            wall;
+        inGroups        1(wall);
         nFaces          378;
-        startFace       50460;
+        startFace       45947;
     }
 )
 
diff --git a/tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/polyMesh/boundary.org b/tutorials/incompressible/pimpleFoam/pitzDaily/0/U
similarity index 57%
rename from tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/polyMesh/boundary.org
rename to tutorials/incompressible/pimpleFoam/pitzDaily/0/U
index 0b4b7a6a88eaba2c614d4cbd143a5510bfdc83d7..885c5b9de439fa3983f723c56d7734369a6248ad 100644
--- a/tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/polyMesh/boundary.org
+++ b/tutorials/incompressible/pimpleFoam/pitzDaily/0/U
@@ -9,60 +9,44 @@ FoamFile
 {
     version     2.0;
     format      ascii;
-    class       polyBoundaryMesh;
-    object      boundary;
+    class       volVectorField;
+    object      U;
 }
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-6
-(
-axis
-{
-    type empty;
-    physicalType empty;
-    nFaces 0;
-    startFace 41031;
-}
+dimensions      [0 1 -1 0 0 0 0];
 
-inlet
-{
-    type patch;
-    physicalType inlet;
-    nFaces 30;
-    startFace 41031;
-}
+internalField   uniform (0 0 0);
 
-wall
+boundaryField
 {
-    type wall;
-    physicalType wall;
-    nFaces 70;
-    startFace 41061;
-}
+    inlet
+    {
+        type            fixedValue;
+        value           uniform (10 0 0);
+    }
 
-atmosphere
-{
-    type patch;
-    physicalType atmosphere;
-    nFaces 175;
-    startFace 41131;
-}
+    outlet
+    {
+        type            zeroGradient;
+    }
 
-front
-{
-    type wedge;
-    physicalType wedge;
-    nFaces 20603;
-    startFace 41306;
-}
+    upperWall
+    {
+        type            fixedValue;
+        value           uniform (0 0 0);
+    }
 
-back
-{
-    type wedge;
-    physicalType wedge;
-    nFaces 20603;
-    startFace 61909;
+    lowerWall
+    {
+        type            fixedValue;
+        value           uniform (0 0 0);
+    }
+
+    frontAndBack
+    {
+        type            empty;
+    }
 }
-)
 
 // ************************************************************************* //
diff --git a/tutorials/incompressible/icoFoam/elbow/constant/polyMesh/boundary b/tutorials/incompressible/pimpleFoam/pitzDaily/0/epsilon
similarity index 54%
rename from tutorials/incompressible/icoFoam/elbow/constant/polyMesh/boundary
rename to tutorials/incompressible/pimpleFoam/pitzDaily/0/epsilon
index fbdbc176b35e0c489628af5632951f8b8c19f2d4..d82c45e6290be093bee3d9a3d6af3f84072a543d 100644
--- a/tutorials/incompressible/icoFoam/elbow/constant/polyMesh/boundary
+++ b/tutorials/incompressible/pimpleFoam/pitzDaily/0/epsilon
@@ -9,50 +9,42 @@ FoamFile
 {
     version     2.0;
     format      ascii;
-    class       polyBoundaryMesh;
-    location    "constant/polyMesh";
-    object      boundary;
+    class       volScalarField;
+    location    "0";
+    object      epsilon;
 }
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-6
-(
-    wall-4
-    {
-        type            wall;
-        nFaces          100;
-        startFace       1300;
-    }
-    velocity-inlet-5
+dimensions      [0 2 -3 0 0 0 0];
+
+internalField   uniform 14.855;
+
+boundaryField
+{
+    inlet
     {
-        type            patch;
-        nFaces          8;
-        startFace       1400;
+        type            fixedValue;
+        value           uniform 14.855;
     }
-    velocity-inlet-6
+    outlet
     {
-        type            patch;
-        nFaces          4;
-        startFace       1408;
+        type            zeroGradient;
     }
-    pressure-outlet-7
+    upperWall
     {
-        type            patch;
-        nFaces          8;
-        startFace       1412;
+        type            epsilonWallFunction;
+        value           uniform 14.855;
     }
-    wall-8
+    lowerWall
     {
-        type            wall;
-        nFaces          34;
-        startFace       1420;
+        type            epsilonWallFunction;
+        value           uniform 14.855;
     }
-    frontAndBackPlanes
+    frontAndBack
     {
         type            empty;
-        nFaces          1836;
-        startFace       1454;
     }
-)
+}
+
 
 // ************************************************************************* //
diff --git a/tutorials/incompressible/pimpleFoam/pitzDaily/0/k b/tutorials/incompressible/pimpleFoam/pitzDaily/0/k
new file mode 100644
index 0000000000000000000000000000000000000000..7de1adf4b5d6b4518dc306b6d4ab6d0f40ea2312
--- /dev/null
+++ b/tutorials/incompressible/pimpleFoam/pitzDaily/0/k
@@ -0,0 +1,50 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       volScalarField;
+    location    "0";
+    object      k;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 2 -2 0 0 0 0];
+
+internalField   uniform 0.375;
+
+boundaryField
+{
+    inlet
+    {
+        type            fixedValue;
+        value           uniform 0.375;
+    }
+    outlet
+    {
+        type            zeroGradient;
+    }
+    upperWall
+    {
+        type            kqRWallFunction;
+        value           uniform 0.375;
+    }
+    lowerWall
+    {
+        type            kqRWallFunction;
+        value           uniform 0.375;
+    }
+    frontAndBack
+    {
+        type            empty;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/incompressible/pimpleFoam/pitzDaily/0/nuTilda b/tutorials/incompressible/pimpleFoam/pitzDaily/0/nuTilda
new file mode 100644
index 0000000000000000000000000000000000000000..cbe04420b91623c7b0736f7f818d8ac8c59634d8
--- /dev/null
+++ b/tutorials/incompressible/pimpleFoam/pitzDaily/0/nuTilda
@@ -0,0 +1,50 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       volScalarField;
+    object      nuTilda;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 2 -1 0 0 0 0];
+
+internalField   uniform 0;
+
+boundaryField
+{
+    inlet
+    {
+        type            fixedValue;
+        value           uniform 0;
+    }
+
+    outlet
+    {
+        type            zeroGradient;
+    }
+
+    upperWall
+    {
+        type            zeroGradient;
+    }
+
+    lowerWall
+    {
+        type            zeroGradient;
+    }
+
+    frontAndBack
+    {
+        type            empty;
+    }
+}
+
+// ************************************************************************* //
diff --git a/tutorials/incompressible/pimpleFoam/pitzDaily/0/nut b/tutorials/incompressible/pimpleFoam/pitzDaily/0/nut
new file mode 100644
index 0000000000000000000000000000000000000000..585d8ec0f4c35a1a0d5c797222096d9483947cce
--- /dev/null
+++ b/tutorials/incompressible/pimpleFoam/pitzDaily/0/nut
@@ -0,0 +1,51 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       volScalarField;
+    location    "0";
+    object      nut;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 2 -1 0 0 0 0];
+
+internalField   uniform 0;
+
+boundaryField
+{
+    inlet
+    {
+        type            calculated;
+        value           uniform 0;
+    }
+    outlet
+    {
+        type            calculated;
+        value           uniform 0;
+    }
+    upperWall
+    {
+        type            nutkWallFunction;
+        value           uniform 0;
+    }
+    lowerWall
+    {
+        type            nutkWallFunction;
+        value           uniform 0;
+    }
+    frontAndBack
+    {
+        type            empty;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/incompressible/pimpleFoam/pitzDaily/0/p b/tutorials/incompressible/pimpleFoam/pitzDaily/0/p
new file mode 100644
index 0000000000000000000000000000000000000000..0fdd33ec47f28523f2ae5b0964b19321c1d92f4d
--- /dev/null
+++ b/tutorials/incompressible/pimpleFoam/pitzDaily/0/p
@@ -0,0 +1,50 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       volScalarField;
+    object      p;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 2 -2 0 0 0 0];
+
+internalField   uniform 0;
+
+boundaryField
+{
+    inlet
+    {
+        type            zeroGradient;
+    }
+
+    outlet
+    {
+        type            fixedValue;
+        value           uniform 0;
+    }
+
+    upperWall
+    {
+        type            zeroGradient;
+    }
+
+    lowerWall
+    {
+        type            zeroGradient;
+    }
+
+    frontAndBack
+    {
+        type            empty;
+    }
+}
+
+// ************************************************************************* //
diff --git a/tutorials/incompressible/pimpleFoam/pitzDaily/constant/RASProperties b/tutorials/incompressible/pimpleFoam/pitzDaily/constant/RASProperties
new file mode 100644
index 0000000000000000000000000000000000000000..a4937b503a46850b2626f0d301e4a07b9f691507
--- /dev/null
+++ b/tutorials/incompressible/pimpleFoam/pitzDaily/constant/RASProperties
@@ -0,0 +1,25 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      RASProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+RASModel        kEpsilon;
+
+turbulence      on;
+
+printCoeffs     on;
+
+
+// ************************************************************************* //
diff --git a/tutorials/incompressible/pimpleFoam/pitzDaily/constant/polyMesh/blockMeshDict b/tutorials/incompressible/pimpleFoam/pitzDaily/constant/polyMesh/blockMeshDict
new file mode 100644
index 0000000000000000000000000000000000000000..0e0fcf1c9855da788effb6cfe4f7773c99bf2594
--- /dev/null
+++ b/tutorials/incompressible/pimpleFoam/pitzDaily/constant/polyMesh/blockMeshDict
@@ -0,0 +1,173 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    object      blockMeshDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+convertToMeters 0.001;
+
+vertices
+(
+    (-20.6 0 -0.5)
+    (-20.6 3 -0.5)
+    (-20.6 12.7 -0.5)
+    (-20.6 25.4 -0.5)
+    (0 -25.4 -0.5)
+    (0 -5 -0.5)
+    (0 0 -0.5)
+    (0 3 -0.5)
+    (0 12.7 -0.5)
+    (0 25.4 -0.5)
+    (206 -25.4 -0.5)
+    (206 -8.5 -0.5)
+    (206 0 -0.5)
+    (206 6.5 -0.5)
+    (206 17 -0.5)
+    (206 25.4 -0.5)
+    (290 -16.6 -0.5)
+    (290 -6.3 -0.5)
+    (290 0 -0.5)
+    (290 4.5 -0.5)
+    (290 11 -0.5)
+    (290 16.6 -0.5)
+    (-20.6 0 0.5)
+    (-20.6 3 0.5)
+    (-20.6 12.7 0.5)
+    (-20.6 25.4 0.5)
+    (0 -25.4 0.5)
+    (0 -5 0.5)
+    (0 0 0.5)
+    (0 3 0.5)
+    (0 12.7 0.5)
+    (0 25.4 0.5)
+    (206 -25.4 0.5)
+    (206 -8.5 0.5)
+    (206 0 0.5)
+    (206 6.5 0.5)
+    (206 17 0.5)
+    (206 25.4 0.5)
+    (290 -16.6 0.5)
+    (290 -6.3 0.5)
+    (290 0 0.5)
+    (290 4.5 0.5)
+    (290 11 0.5)
+    (290 16.6 0.5)
+);
+
+blocks
+(
+    hex (0 6 7 1 22 28 29 23) (18 7 1) simpleGrading (0.5 1.8 1)
+    hex (1 7 8 2 23 29 30 24) (18 10 1) simpleGrading (0.5 4 1)
+    hex (2 8 9 3 24 30 31 25) (18 13 1) simpleGrading (0.5 0.25 1)
+    hex (4 10 11 5 26 32 33 27) (180 18 1) simpleGrading (4 1 1)
+    hex (5 11 12 6 27 33 34 28) (180 9 1) edgeGrading (4 4 4 4 0.5 1 1 0.5 1 1 1 1)
+    hex (6 12 13 7 28 34 35 29) (180 7 1) edgeGrading (4 4 4 4 1.8 1 1 1.8 1 1 1 1)
+    hex (7 13 14 8 29 35 36 30) (180 10 1) edgeGrading (4 4 4 4 4 1 1 4 1 1 1 1)
+    hex (8 14 15 9 30 36 37 31) (180 13 1) simpleGrading (4 0.25 1)
+    hex (10 16 17 11 32 38 39 33) (25 18 1) simpleGrading (2.5 1 1)
+    hex (11 17 18 12 33 39 40 34) (25 9 1) simpleGrading (2.5 1 1)
+    hex (12 18 19 13 34 40 41 35) (25 7 1) simpleGrading (2.5 1 1)
+    hex (13 19 20 14 35 41 42 36) (25 10 1) simpleGrading (2.5 1 1)
+    hex (14 20 21 15 36 42 43 37) (25 13 1) simpleGrading (2.5 0.25 1)
+);
+
+edges
+(
+);
+
+boundary
+(
+    inlet
+    {
+        type patch;
+        faces
+        (
+            (0 22 23 1)
+            (1 23 24 2)
+            (2 24 25 3)
+        );
+    }
+    outlet
+    {
+        type patch;
+        faces
+        (
+            (16 17 39 38)
+            (17 18 40 39)
+            (18 19 41 40)
+            (19 20 42 41)
+            (20 21 43 42)
+        );
+    }
+    upperWall
+    {
+        type wall;
+        faces
+        (
+            (3 25 31 9)
+            (9 31 37 15)
+            (15 37 43 21)
+        );
+    }
+    lowerWall
+    {
+        type wall;
+        faces
+        (
+            (0 6 28 22)
+            (6 5 27 28)
+            (5 4 26 27)
+            (4 10 32 26)
+            (10 16 38 32)
+        );
+    }
+    frontAndBack
+    {
+        type empty;
+        faces
+        (
+            (22 28 29 23)
+            (23 29 30 24)
+            (24 30 31 25)
+            (26 32 33 27)
+            (27 33 34 28)
+            (28 34 35 29)
+            (29 35 36 30)
+            (30 36 37 31)
+            (32 38 39 33)
+            (33 39 40 34)
+            (34 40 41 35)
+            (35 41 42 36)
+            (36 42 43 37)
+            (0 1 7 6)
+            (1 2 8 7)
+            (2 3 9 8)
+            (4 5 11 10)
+            (5 6 12 11)
+            (6 7 13 12)
+            (7 8 14 13)
+            (8 9 15 14)
+            (10 11 17 16)
+            (11 12 18 17)
+            (12 13 19 18)
+            (13 14 20 19)
+            (14 15 21 20)
+        );
+    }
+);
+
+mergePatchPairs
+(
+);
+
+// ************************************************************************* //
diff --git a/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/polyMesh/boundary b/tutorials/incompressible/pimpleFoam/pitzDaily/constant/polyMesh/boundary
similarity index 65%
rename from tutorials/compressible/rhoPimplecFoam/angledDuct/constant/polyMesh/boundary
rename to tutorials/incompressible/pimpleFoam/pitzDaily/constant/polyMesh/boundary
index 0abd1608aba0dcb6aa66c9488133a3c4b51c7588..221823b308d5063df215d77e90a11eae26d6c1c6 100644
--- a/tutorials/compressible/rhoPimplecFoam/angledDuct/constant/polyMesh/boundary
+++ b/tutorials/incompressible/pimpleFoam/pitzDaily/constant/polyMesh/boundary
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  dev                                   |
+|  \\    /   O peration     | Version:  2.2.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
@@ -15,43 +15,38 @@ FoamFile
 }
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-6
+5
 (
-    front
+    inlet
     {
-        type            wall;
-        nFaces          700;
-        startFace       63400;
+        type            patch;
+        nFaces          30;
+        startFace       24170;
     }
-    back
+    outlet
     {
-        type            wall;
-        nFaces          700;
-        startFace       64100;
+        type            patch;
+        nFaces          57;
+        startFace       24200;
     }
-    wall
+    upperWall
     {
         type            wall;
-        nFaces          1400;
-        startFace       64800;
+        nFaces          223;
+        startFace       24257;
     }
-    porosityWall
+    lowerWall
     {
         type            wall;
-        nFaces          1600;
-        startFace       66200;
+        nFaces          250;
+        startFace       24480;
     }
-    inlet
-    {
-        type            patch;
-        nFaces          400;
-        startFace       67800;
-    }
-    outlet
+    frontAndBack
     {
-        type            patch;
-        nFaces          400;
-        startFace       68200;
+        type            empty;
+        inGroups        1(empty);
+        nFaces          24450;
+        startFace       24730;
     }
 )
 
diff --git a/tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/polyMesh/boundary b/tutorials/incompressible/pimpleFoam/pitzDaily/constant/transportProperties
similarity index 57%
rename from tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/polyMesh/boundary
rename to tutorials/incompressible/pimpleFoam/pitzDaily/constant/transportProperties
index 0b4b7a6a88eaba2c614d4cbd143a5510bfdc83d7..b40b7d66cd884b7a54d4c7a61b50b1e39a466150 100644
--- a/tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/polyMesh/boundary
+++ b/tutorials/incompressible/pimpleFoam/pitzDaily/constant/transportProperties
@@ -9,60 +9,31 @@ FoamFile
 {
     version     2.0;
     format      ascii;
-    class       polyBoundaryMesh;
-    object      boundary;
+    class       dictionary;
+    location    "constant";
+    object      transportProperties;
 }
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-6
-(
-axis
-{
-    type empty;
-    physicalType empty;
-    nFaces 0;
-    startFace 41031;
-}
+transportModel  Newtonian;
 
-inlet
-{
-    type patch;
-    physicalType inlet;
-    nFaces 30;
-    startFace 41031;
-}
+nu              nu [ 0 2 -1 0 0 0 0 ] 1e-05;
 
-wall
+CrossPowerLawCoeffs
 {
-    type wall;
-    physicalType wall;
-    nFaces 70;
-    startFace 41061;
+    nu0             nu0 [ 0 2 -1 0 0 0 0 ] 1e-06;
+    nuInf           nuInf [ 0 2 -1 0 0 0 0 ] 1e-06;
+    m               m [ 0 0 1 0 0 0 0 ] 1;
+    n               n [ 0 0 0 0 0 0 0 ] 1;
 }
 
-atmosphere
+BirdCarreauCoeffs
 {
-    type patch;
-    physicalType atmosphere;
-    nFaces 175;
-    startFace 41131;
+    nu0             nu0 [ 0 2 -1 0 0 0 0 ] 1e-06;
+    nuInf           nuInf [ 0 2 -1 0 0 0 0 ] 1e-06;
+    k               k [ 0 0 1 0 0 0 0 ] 0;
+    n               n [ 0 0 0 0 0 0 0 ] 1;
 }
 
-front
-{
-    type wedge;
-    physicalType wedge;
-    nFaces 20603;
-    startFace 41306;
-}
-
-back
-{
-    type wedge;
-    physicalType wedge;
-    nFaces 20603;
-    startFace 61909;
-}
-)
 
 // ************************************************************************* //
diff --git a/tutorials/incompressible/pimpleFoam/pitzDaily/constant/turbulenceProperties b/tutorials/incompressible/pimpleFoam/pitzDaily/constant/turbulenceProperties
new file mode 100644
index 0000000000000000000000000000000000000000..e7fa28c74a5fead3fbcdd79b5587ef684e8bacb4
--- /dev/null
+++ b/tutorials/incompressible/pimpleFoam/pitzDaily/constant/turbulenceProperties
@@ -0,0 +1,20 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      turbulenceProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+simulationType RASModel;
+
+// ************************************************************************* //
diff --git a/tutorials/incompressible/pimpleFoam/pitzDaily/system/controlDict b/tutorials/incompressible/pimpleFoam/pitzDaily/system/controlDict
new file mode 100644
index 0000000000000000000000000000000000000000..a8ea900b3c47194aaf01f6803065fe4306bc6395
--- /dev/null
+++ b/tutorials/incompressible/pimpleFoam/pitzDaily/system/controlDict
@@ -0,0 +1,52 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "system";
+    object      controlDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+application     pimpleFoam;
+
+startFrom       latestTime;
+
+startTime       0;
+
+stopAt          endTime;
+
+endTime         1;
+
+deltaT          0.0001;
+
+writeControl    adjustableRunTime;
+
+writeInterval   0.001;
+
+purgeWrite      0;
+
+writeFormat     ascii;
+
+writePrecision  6;
+
+writeCompression off;
+
+timeFormat      general;
+
+timePrecision   6;
+
+runTimeModifiable yes;
+
+adjustTimeStep  yes;
+
+maxCo           5;
+
+// ************************************************************************* //
diff --git a/tutorials/incompressible/pimpleFoam/pitzDaily/system/fvSchemes b/tutorials/incompressible/pimpleFoam/pitzDaily/system/fvSchemes
new file mode 100644
index 0000000000000000000000000000000000000000..926d489aae55eb3d059e41849197d58c6129a2b3
--- /dev/null
+++ b/tutorials/incompressible/pimpleFoam/pitzDaily/system/fvSchemes
@@ -0,0 +1,71 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "system";
+    object      fvSchemes;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+ddtSchemes
+{
+    default         Euler;
+}
+
+gradSchemes
+{
+    default         Gauss linear;
+    grad(p)         Gauss linear;
+    grad(U)         Gauss linear;
+}
+
+divSchemes
+{
+    default         none;
+    div(phi,U)      bounded Gauss linearUpwind grad(U);
+    div(phi,k)      bounded Gauss upwind;
+    div(phi,epsilon) bounded Gauss upwind;
+    div(phi,R)      bounded Gauss upwind;
+    div(R)          Gauss linear;
+    div(phi,nuTilda) bounded Gauss upwind;
+    div((nuEff*dev(T(grad(U))))) Gauss linear;
+}
+
+laplacianSchemes
+{
+    default         none;
+    laplacian(nuEff,U) Gauss linear corrected;
+    laplacian(rAUf,p)  Gauss linear corrected;
+    laplacian(DkEff,k) Gauss linear corrected;
+    laplacian(DepsilonEff,epsilon) Gauss linear corrected;
+    laplacian(DREff,R) Gauss linear corrected;
+    laplacian(DnuTildaEff,nuTilda) Gauss linear corrected;
+}
+
+interpolationSchemes
+{
+    default         linear;
+    interpolate(U)  linear;
+}
+
+snGradSchemes
+{
+    default         corrected;
+}
+
+fluxRequired
+{
+    default         no;
+    p               ;
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/incompressible/pimpleFoam/pitzDaily/system/fvSolution b/tutorials/incompressible/pimpleFoam/pitzDaily/system/fvSolution
new file mode 100644
index 0000000000000000000000000000000000000000..880d7bef7b27665cfb7675d2036a2b2faf848267
--- /dev/null
+++ b/tutorials/incompressible/pimpleFoam/pitzDaily/system/fvSolution
@@ -0,0 +1,62 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "system";
+    object      fvSolution;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+solvers
+{
+    p
+    {
+        solver           GAMG;
+        tolerance        1e-7;
+        relTol           0.01;
+
+        smoother         GaussSeidel;
+
+        cacheAgglomeration true;
+        nCellsInCoarsestLevel 10;
+        agglomerator     faceAreaPair;
+        mergeLevels      1;
+    }
+
+    pFinal
+    {
+        $p;
+        relTol          0;
+    }
+
+    "(U|k|epsilon)"
+    {
+        solver          PBiCG;
+        preconditioner  DILU;
+        tolerance       1e-05;
+        relTol          0.1;
+    }
+
+    "(U|k|epsilon)Final"
+    {
+        $U;
+        relTol          0;
+    }
+}
+
+PIMPLE
+{
+    nNonOrthogonalCorrectors 0;
+    nCorrectors         2;
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/T b/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/T
index 561ca236be3bbed252ef63b29c24063a3bea4c6b..76e54ad382f43e125823fe484246da452995bbbd 100644
--- a/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/T
+++ b/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/T
@@ -29,7 +29,7 @@ boundaryField
     {
         type            zeroGradient;
     }
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/U b/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/U
index ad11b09e1e850ffc6943363fb5dfe9128be79ec2..fe2432b8aa31373eaca58308bfd278fc01dbf8bd 100644
--- a/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/U
+++ b/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/U
@@ -30,7 +30,7 @@ boundaryField
         type            fixedValue;
         value           uniform (0 0 0);
     }
-    wall
+    walls
     {
         type            fixedValue;
         value           uniform (0 0 0);
diff --git a/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/epsilon b/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/epsilon
index 6d30851be3cba86edd2360f6cb107b1f652905a9..21b1e98ef916e45e087b197e36c0e1d1e8190105 100644
--- a/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/epsilon
+++ b/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/epsilon
@@ -33,7 +33,7 @@ boundaryField
         value           uniform 200;
     }
 
-    wall
+    walls
     {
         type            epsilonWallFunction;
         value           uniform 200;
diff --git a/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/k b/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/k
index 673cfc8310efe40606aa7b4207dff3ee5febdda5..cd7aa31096656069b0dd238accfc2160b6efb306 100644
--- a/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/k
+++ b/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/k
@@ -33,7 +33,7 @@ boundaryField
         value           uniform 1;
     }
 
-    wall
+    walls
     {
         type            kqRWallFunction;
         value           uniform 1;
diff --git a/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/nut b/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/nut
index 5db002b34bb9d7deddd49f503c5264d352725c9c..fcb2bc9b0086d3236de4cfe6d5891b3035585ce9 100644
--- a/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/nut
+++ b/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/nut
@@ -33,7 +33,7 @@ boundaryField
         value           uniform 0;
     }
 
-    wall
+    walls
     {
         type            nutkWallFunction;
         value           uniform 0;
diff --git a/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/p b/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/p
index 865e81e29f92154d863cf935505f6fdcd626ca08..dd95d3a8eb3530417c1373e9ff5d94457a8182de 100644
--- a/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/p
+++ b/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/0/p
@@ -28,7 +28,7 @@ boundaryField
     {
         type            zeroGradient;
     }
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/constant/polyMesh/blockMeshDict.m4 b/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/constant/polyMesh/blockMeshDict.m4
index 79da11e10ac8f655aa16fc6287c9496875d8672f..09a4670392e59bae438f7ff2a8f5e7a3c1a66a6a 100644
--- a/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/constant/polyMesh/blockMeshDict.m4
+++ b/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/constant/polyMesh/blockMeshDict.m4
@@ -126,7 +126,7 @@ patches
     backQuad(poro1, out1, out2, poro2)
     )
 
-    wall wall
+    wall walls
     (
     // inlet block
     quad2D(in1, join1)
diff --git a/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/constant/polyMesh/boundary b/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/constant/polyMesh/boundary
index a664893343e7216491ca9913ee0171ee31980aba..1e23642ed6cb5dde77b349a2cff0acebffe36789 100644
--- a/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/constant/polyMesh/boundary
+++ b/tutorials/incompressible/porousSimpleFoam/angledDuctImplicit/constant/polyMesh/boundary
@@ -29,7 +29,7 @@ FoamFile
         nFaces          700;
         startFace       64100;
     }
-    wall
+    walls
     {
         type            wall;
         nFaces          1400;
diff --git a/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/T b/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/T
index 52286928be798d362a503978df62cb9d6a68d8d3..0b87371528b98effb17f6a8bc9b76206d755c060 100644
--- a/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/T
+++ b/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/T
@@ -29,7 +29,7 @@ boundaryField
     {
         type            zeroGradient;
     }
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/U b/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/U
index c411935183eb96211ba3ffb5df7117f635dbedc5..155713c25c47f833c5040dd47fcffac88a467e36 100644
--- a/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/U
+++ b/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/U
@@ -30,7 +30,7 @@ boundaryField
         type            fixedValue;
         value           uniform (0 0 0);
     }
-    wall
+    walls
     {
         type            fixedValue;
         value           uniform (0 0 0);
diff --git a/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/epsilon b/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/epsilon
index fc7c3ed34935271859d2f46561a4407d1b0a0445..1d7a756c5c6967a7a06e824f3bfe9d188345a67f 100644
--- a/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/epsilon
+++ b/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/epsilon
@@ -33,7 +33,7 @@ boundaryField
         value           uniform 200;
     }
 
-    wall
+    walls
     {
         type            epsilonWallFunction;
         value           uniform 200;
diff --git a/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/k b/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/k
index 13f51bec6b7419e4702012f93b2037be58f5dff0..1626050988f1c29c8a348c0276a46a7692b54871 100644
--- a/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/k
+++ b/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/k
@@ -33,7 +33,7 @@ boundaryField
         value           uniform 1;
     }
 
-    wall
+    walls
     {
         type            kqRWallFunction;
         value           uniform 1;
diff --git a/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/nut b/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/nut
index 6f819a789120c8c1d52e5a2a99f77f8e4da66b7e..86f8c112857f3890be3021530aae3bf3080b119c 100644
--- a/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/nut
+++ b/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/nut
@@ -33,7 +33,7 @@ boundaryField
         value           uniform 0;
     }
 
-    wall
+    walls
     {
         type            nutkWallFunction;
         value           uniform 0;
diff --git a/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/p b/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/p
index 682ac792a89a1c4fcbe1ec8fb2b605c6fe1a0043..0d408ac6316de7a297696c3117186575325f6699 100644
--- a/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/p
+++ b/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/0/p
@@ -28,7 +28,7 @@ boundaryField
     {
         type            zeroGradient;
     }
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/Allrun.pre b/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/Allrun.pre
index 3a02370217ed1075a46e2608b74fd03c33a82181..14f681a614d78d4daa1a17d833fe83f1001c8bc4 100755
--- a/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/Allrun.pre
+++ b/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/Allrun.pre
@@ -22,7 +22,7 @@ runApplication checkMesh -allTopology -allGeometry -latestTime
 latestTime=`foamInfoExec -latestTime`
 
 # Move the mesh into polyMesh
-\rm -r constant/polyMesh
+\rm -rf constant/polyMesh
 \mv "${latestTime}"/polyMesh constant
 
 # Clean up intermediate meshes
diff --git a/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/system/meshDict.geometry b/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/system/meshDict.geometry
index b3d5aa612816da6745b6c3ad3b7375be939948d3..83061a79752173111ca7e39c7bf9cc523c20d82a 100644
--- a/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/system/meshDict.geometry
+++ b/tutorials/incompressible/porousSimpleFoam/straightDuctImplicit/system/meshDict.geometry
@@ -23,7 +23,7 @@ straightDuct.stl
     {
         wall
         {
-            name wall;
+            name walls;
         }
         porosityWall
         {
diff --git a/tutorials/incompressible/simpleFoam/airFoil2D/0/U b/tutorials/incompressible/simpleFoam/airFoil2D/0/U
index 0f4b7d581b326a608a989c0d0f6f1fd9e5629421..3fa0d8ab8baa0ac63f6fd106ff55e73110487c26 100644
--- a/tutorials/incompressible/simpleFoam/airFoil2D/0/U
+++ b/tutorials/incompressible/simpleFoam/airFoil2D/0/U
@@ -32,7 +32,7 @@ boundaryField
         freestreamValue uniform (25.75 3.62 0);
     }
 
-    wall
+    walls
     {
         type            fixedValue;
         value           uniform (0 0 0);
diff --git a/tutorials/incompressible/simpleFoam/airFoil2D/0/nuTilda b/tutorials/incompressible/simpleFoam/airFoil2D/0/nuTilda
index 90565ca85a1ad59195b1db85330e9c297e4221a0..42e1dccd972b8fe1eb393ae067de0ca4b8c0be24 100644
--- a/tutorials/incompressible/simpleFoam/airFoil2D/0/nuTilda
+++ b/tutorials/incompressible/simpleFoam/airFoil2D/0/nuTilda
@@ -32,7 +32,7 @@ boundaryField
         freestreamValue uniform 0.14;
     }
 
-    wall
+    walls
     {
         type            fixedValue;
         value           uniform 0;
diff --git a/tutorials/incompressible/simpleFoam/airFoil2D/0/nut b/tutorials/incompressible/simpleFoam/airFoil2D/0/nut
index 688ffe90ffafd7a83b8b9dc0a8186850f8be4738..1e2a80af91cd3c7a1490decc154f9926aa3a1592 100644
--- a/tutorials/incompressible/simpleFoam/airFoil2D/0/nut
+++ b/tutorials/incompressible/simpleFoam/airFoil2D/0/nut
@@ -32,7 +32,7 @@ boundaryField
         freestreamValue uniform 0.14;
     }
 
-    wall
+    walls
     {
         type            nutUSpaldingWallFunction;
         value           uniform 0;
diff --git a/tutorials/incompressible/simpleFoam/airFoil2D/0/p b/tutorials/incompressible/simpleFoam/airFoil2D/0/p
index 76d0d89ff59b60aa2817271ecbf82b64dbe325d1..5e451816728d7349339ea0b3670fda6503fbe328 100644
--- a/tutorials/incompressible/simpleFoam/airFoil2D/0/p
+++ b/tutorials/incompressible/simpleFoam/airFoil2D/0/p
@@ -30,7 +30,7 @@ boundaryField
         type            freestreamPressure;
     }
 
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/incompressible/simpleFoam/airFoil2D/constant/polyMesh/boundary b/tutorials/incompressible/simpleFoam/airFoil2D/constant/polyMesh/boundary
index 5bca16c74ece39f11383d0ae58869bcad1b5e1af..34e79da6d3ee3b2d58c47abac477f9463e3111f2 100644
--- a/tutorials/incompressible/simpleFoam/airFoil2D/constant/polyMesh/boundary
+++ b/tutorials/incompressible/simpleFoam/airFoil2D/constant/polyMesh/boundary
@@ -31,7 +31,7 @@ outlet
     startFace 21388;
 }
 
-wall
+walls
 {
     type wall;
     physicalType wall;
diff --git a/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/0/epsilon b/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/0/epsilon
index b70f15f11994bfb3c213f3ff4dcc453c323b1b64..01dccefae73064164ce2566459eb4f2a214c7235 100644
--- a/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/0/epsilon
+++ b/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/0/epsilon
@@ -26,41 +26,6 @@ boundaryField
         type            timeVaryingMappedFixedValue;
         setAverage      0;
         offset          0;
-        value           nonuniform List<scalar>
-30
-(
-9813.84
-8665.24
-1866.31
-755.118
-205.654
-76.6694
-28.4518
-16.0868
-15.9867
-11.0187
-7.95753
-5.26064
-3.44136
-2.55317
-2.27183
-2.33608
-2.9115
-3.59492
-3.0497
-2.716
-2.9325
-3.88456
-6.91821
-14.9754
-37.5461
-217.022
-2043.58
-4864.22
-6244
-6334.7
-)
-;
     }
     outlet
     {
diff --git a/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/0/k b/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/0/k
index f5f11a1aed3de9e8d9b76526cbf6fefc45853167..c0fa4d80d420f4f9165ab16ace2534d1fcc0d92d 100644
--- a/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/0/k
+++ b/tutorials/incompressible/simpleFoam/pitzDailyExptInlet/0/k
@@ -26,41 +26,6 @@ boundaryField
         type            timeVaryingMappedFixedValue;
         setAverage      0;
         offset          0;
-        value           nonuniform List<scalar>
-30
-(
-2.95219
-2.54219
-0.725449
-0.486465
-0.353566
-0.240375
-0.172984
-0.147052
-0.146827
-0.135658
-0.12147
-0.0942189
-0.0833465
-0.0828453
-0.0955983
-0.0920838
-0.0967682
-0.0990811
-0.100866
-0.101556
-0.0967155
-0.0841739
-0.0904567
-0.130411
-0.194046
-0.219327
-0.975528
-2.22578
-3.12421
-2.28104
-)
-;
     }
     outlet
     {
diff --git a/tutorials/lagrangian/DPMFoam/Goldschmidt/0/U.air b/tutorials/lagrangian/DPMFoam/Goldschmidt/0/U.air
new file mode 100644
index 0000000000000000000000000000000000000000..486a026f8d2416e4b22fb9e2cc7b9aa3b69a4b76
--- /dev/null
+++ b/tutorials/lagrangian/DPMFoam/Goldschmidt/0/U.air
@@ -0,0 +1,54 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      binary;
+    class       volVectorField;
+    location    "0";
+    object      U.air;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 1 -1 0 0 0 0];
+
+internalField   uniform (0 0 0);
+
+boundaryField
+{
+    walls
+    {
+        type            fixedValue;
+        value           uniform (0 0 0);
+    }
+
+    top
+    {
+        type            pressureInletOutletVelocity;
+        phi             phi.air;
+        inletValue      uniform (0 0 0);
+        value           uniform (0 0 0);
+    }
+
+    bottom
+    {
+        type            interstitialInletVelocity;
+        inletVelocity   uniform (0 0 1.875);
+        value           uniform (0 0 1.875);
+        phi             phi.air;
+        alpha           alpha.air;
+    }
+
+    frontAndBack
+    {
+        type            symmetry;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/DPMFoam/Goldschmidt/0/p b/tutorials/lagrangian/DPMFoam/Goldschmidt/0/p
new file mode 100644
index 0000000000000000000000000000000000000000..d4715eccd0983568890a1fa197a204ef1b345a27
--- /dev/null
+++ b/tutorials/lagrangian/DPMFoam/Goldschmidt/0/p
@@ -0,0 +1,50 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       volScalarField;
+    object      p;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 2 -2 0 0 0 0];
+
+internalField   uniform 0;
+
+boundaryField
+{
+    walls
+    {
+        type            fixedFluxPressure;
+        phi             phi.air;
+        value           $internalField;
+    }
+
+    bottom
+    {
+        type            fixedFluxPressure;
+        phi             phi.air;
+        value           $internalField;
+    }
+
+    top
+    {
+        type            fixedValue;
+        phi             phi.air;
+        value           $internalField;
+    }
+
+    frontAndBack
+    {
+        type            symmetry;
+    }
+}
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/g b/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/g
new file mode 100644
index 0000000000000000000000000000000000000000..a9a9ffdf6631398e63155d4b0650f5636fbb0463
--- /dev/null
+++ b/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/g
@@ -0,0 +1,22 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                 |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       uniformDimensionedVectorField;
+    location    "constant";
+    object      g;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 1 -2 0 0 0 0];
+value           ( 0 0 -9.81 );
+
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/kinematicCloudPositions b/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/kinematicCloudPositions
new file mode 100644
index 0000000000000000000000000000000000000000..d12dfd9cc7cf0195c31b60c95130d97e21a53f09
--- /dev/null
+++ b/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/kinematicCloudPositions
@@ -0,0 +1,24770 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       vectorField;
+    object      kinematicCloudPositions;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+(
+(-0.0060 -0.0735 0.0015)
+(-0.0030 -0.0735 0.0015)
+(0.0000 -0.0735 0.0015)
+(0.0030 -0.0735 0.0015)
+(0.0060 -0.0735 0.0015)
+(-0.0060 -0.0705 0.0015)
+(-0.0030 -0.0705 0.0015)
+(0.0000 -0.0705 0.0015)
+(0.0030 -0.0705 0.0015)
+(0.0060 -0.0705 0.0015)
+(-0.0060 -0.0675 0.0015)
+(-0.0030 -0.0675 0.0015)
+(0.0000 -0.0675 0.0015)
+(0.0030 -0.0675 0.0015)
+(0.0060 -0.0675 0.0015)
+(-0.0060 -0.0645 0.0015)
+(-0.0030 -0.0645 0.0015)
+(0.0000 -0.0645 0.0015)
+(0.0030 -0.0645 0.0015)
+(0.0060 -0.0645 0.0015)
+(-0.0060 -0.0615 0.0015)
+(-0.0030 -0.0615 0.0015)
+(0.0000 -0.0615 0.0015)
+(0.0030 -0.0615 0.0015)
+(0.0060 -0.0615 0.0015)
+(-0.0060 -0.0585 0.0015)
+(-0.0030 -0.0585 0.0015)
+(0.0000 -0.0585 0.0015)
+(0.0030 -0.0585 0.0015)
+(0.0060 -0.0585 0.0015)
+(-0.0060 -0.0555 0.0015)
+(-0.0030 -0.0555 0.0015)
+(0.0000 -0.0555 0.0015)
+(0.0030 -0.0555 0.0015)
+(0.0060 -0.0555 0.0015)
+(-0.0060 -0.0525 0.0015)
+(-0.0030 -0.0525 0.0015)
+(0.0000 -0.0525 0.0015)
+(0.0030 -0.0525 0.0015)
+(0.0060 -0.0525 0.0015)
+(-0.0060 -0.0495 0.0015)
+(-0.0030 -0.0495 0.0015)
+(0.0000 -0.0495 0.0015)
+(0.0030 -0.0495 0.0015)
+(0.0060 -0.0495 0.0015)
+(-0.0060 -0.0465 0.0015)
+(-0.0030 -0.0465 0.0015)
+(0.0000 -0.0465 0.0015)
+(0.0030 -0.0465 0.0015)
+(0.0060 -0.0465 0.0015)
+(-0.0060 -0.0435 0.0015)
+(-0.0030 -0.0435 0.0015)
+(0.0000 -0.0435 0.0015)
+(0.0030 -0.0435 0.0015)
+(0.0060 -0.0435 0.0015)
+(-0.0060 -0.0405 0.0015)
+(-0.0030 -0.0405 0.0015)
+(0.0000 -0.0405 0.0015)
+(0.0030 -0.0405 0.0015)
+(0.0060 -0.0405 0.0015)
+(-0.0060 -0.0375 0.0015)
+(-0.0030 -0.0375 0.0015)
+(0.0000 -0.0375 0.0015)
+(0.0030 -0.0375 0.0015)
+(0.0060 -0.0375 0.0015)
+(-0.0060 -0.0345 0.0015)
+(-0.0030 -0.0345 0.0015)
+(0.0000 -0.0345 0.0015)
+(0.0030 -0.0345 0.0015)
+(0.0060 -0.0345 0.0015)
+(-0.0060 -0.0315 0.0015)
+(-0.0030 -0.0315 0.0015)
+(0.0000 -0.0315 0.0015)
+(0.0030 -0.0315 0.0015)
+(0.0060 -0.0315 0.0015)
+(-0.0060 -0.0285 0.0015)
+(-0.0030 -0.0285 0.0015)
+(0.0000 -0.0285 0.0015)
+(0.0030 -0.0285 0.0015)
+(0.0060 -0.0285 0.0015)
+(-0.0060 -0.0255 0.0015)
+(-0.0030 -0.0255 0.0015)
+(0.0000 -0.0255 0.0015)
+(0.0030 -0.0255 0.0015)
+(0.0060 -0.0255 0.0015)
+(-0.0060 -0.0225 0.0015)
+(-0.0030 -0.0225 0.0015)
+(0.0000 -0.0225 0.0015)
+(0.0030 -0.0225 0.0015)
+(0.0060 -0.0225 0.0015)
+(-0.0060 -0.0195 0.0015)
+(-0.0030 -0.0195 0.0015)
+(0.0000 -0.0195 0.0015)
+(0.0030 -0.0195 0.0015)
+(0.0060 -0.0195 0.0015)
+(-0.0060 -0.0165 0.0015)
+(-0.0030 -0.0165 0.0015)
+(0.0000 -0.0165 0.0015)
+(0.0030 -0.0165 0.0015)
+(0.0060 -0.0165 0.0015)
+(-0.0060 -0.0135 0.0015)
+(-0.0030 -0.0135 0.0015)
+(0.0000 -0.0135 0.0015)
+(0.0030 -0.0135 0.0015)
+(0.0060 -0.0135 0.0015)
+(-0.0060 -0.0105 0.0015)
+(-0.0030 -0.0105 0.0015)
+(0.0000 -0.0105 0.0015)
+(0.0030 -0.0105 0.0015)
+(0.0060 -0.0105 0.0015)
+(-0.0060 -0.0075 0.0015)
+(-0.0030 -0.0075 0.0015)
+(0.0000 -0.0075 0.0015)
+(0.0030 -0.0075 0.0015)
+(0.0060 -0.0075 0.0015)
+(-0.0060 -0.0045 0.0015)
+(-0.0030 -0.0045 0.0015)
+(0.0000 -0.0045 0.0015)
+(0.0030 -0.0045 0.0015)
+(0.0060 -0.0045 0.0015)
+(-0.0060 -0.0015 0.0015)
+(-0.0030 -0.0015 0.0015)
+(0.0000 -0.0015 0.0015)
+(0.0030 -0.0015 0.0015)
+(0.0060 -0.0015 0.0015)
+(-0.0060 0.0015 0.0015)
+(-0.0030 0.0015 0.0015)
+(0.0000 0.0015 0.0015)
+(0.0030 0.0015 0.0015)
+(0.0060 0.0015 0.0015)
+(-0.0060 0.0045 0.0015)
+(-0.0030 0.0045 0.0015)
+(0.0000 0.0045 0.0015)
+(0.0030 0.0045 0.0015)
+(0.0060 0.0045 0.0015)
+(-0.0060 0.0075 0.0015)
+(-0.0030 0.0075 0.0015)
+(0.0000 0.0075 0.0015)
+(0.0030 0.0075 0.0015)
+(0.0060 0.0075 0.0015)
+(-0.0060 0.0105 0.0015)
+(-0.0030 0.0105 0.0015)
+(0.0000 0.0105 0.0015)
+(0.0030 0.0105 0.0015)
+(0.0060 0.0105 0.0015)
+(-0.0060 0.0135 0.0015)
+(-0.0030 0.0135 0.0015)
+(0.0000 0.0135 0.0015)
+(0.0030 0.0135 0.0015)
+(0.0060 0.0135 0.0015)
+(-0.0060 0.0165 0.0015)
+(-0.0030 0.0165 0.0015)
+(0.0000 0.0165 0.0015)
+(0.0030 0.0165 0.0015)
+(0.0060 0.0165 0.0015)
+(-0.0060 0.0195 0.0015)
+(-0.0030 0.0195 0.0015)
+(0.0000 0.0195 0.0015)
+(0.0030 0.0195 0.0015)
+(0.0060 0.0195 0.0015)
+(-0.0060 0.0225 0.0015)
+(-0.0030 0.0225 0.0015)
+(0.0000 0.0225 0.0015)
+(0.0030 0.0225 0.0015)
+(0.0060 0.0225 0.0015)
+(-0.0060 0.0255 0.0015)
+(-0.0030 0.0255 0.0015)
+(0.0000 0.0255 0.0015)
+(0.0030 0.0255 0.0015)
+(0.0060 0.0255 0.0015)
+(-0.0060 0.0285 0.0015)
+(-0.0030 0.0285 0.0015)
+(0.0000 0.0285 0.0015)
+(0.0030 0.0285 0.0015)
+(0.0060 0.0285 0.0015)
+(-0.0060 0.0315 0.0015)
+(-0.0030 0.0315 0.0015)
+(0.0000 0.0315 0.0015)
+(0.0030 0.0315 0.0015)
+(0.0060 0.0315 0.0015)
+(-0.0060 0.0345 0.0015)
+(-0.0030 0.0345 0.0015)
+(0.0000 0.0345 0.0015)
+(0.0030 0.0345 0.0015)
+(0.0060 0.0345 0.0015)
+(-0.0060 0.0375 0.0015)
+(-0.0030 0.0375 0.0015)
+(0.0000 0.0375 0.0015)
+(0.0030 0.0375 0.0015)
+(0.0060 0.0375 0.0015)
+(-0.0060 0.0405 0.0015)
+(-0.0030 0.0405 0.0015)
+(0.0000 0.0405 0.0015)
+(0.0030 0.0405 0.0015)
+(0.0060 0.0405 0.0015)
+(-0.0060 0.0435 0.0015)
+(-0.0030 0.0435 0.0015)
+(0.0000 0.0435 0.0015)
+(0.0030 0.0435 0.0015)
+(0.0060 0.0435 0.0015)
+(-0.0060 0.0465 0.0015)
+(-0.0030 0.0465 0.0015)
+(0.0000 0.0465 0.0015)
+(0.0030 0.0465 0.0015)
+(0.0060 0.0465 0.0015)
+(-0.0060 0.0495 0.0015)
+(-0.0030 0.0495 0.0015)
+(0.0000 0.0495 0.0015)
+(0.0030 0.0495 0.0015)
+(0.0060 0.0495 0.0015)
+(-0.0060 0.0525 0.0015)
+(-0.0030 0.0525 0.0015)
+(0.0000 0.0525 0.0015)
+(0.0030 0.0525 0.0015)
+(0.0060 0.0525 0.0015)
+(-0.0060 0.0555 0.0015)
+(-0.0030 0.0555 0.0015)
+(0.0000 0.0555 0.0015)
+(0.0030 0.0555 0.0015)
+(0.0060 0.0555 0.0015)
+(-0.0060 0.0585 0.0015)
+(-0.0030 0.0585 0.0015)
+(0.0000 0.0585 0.0015)
+(0.0030 0.0585 0.0015)
+(0.0060 0.0585 0.0015)
+(-0.0060 0.0615 0.0015)
+(-0.0030 0.0615 0.0015)
+(0.0000 0.0615 0.0015)
+(0.0030 0.0615 0.0015)
+(0.0060 0.0615 0.0015)
+(-0.0060 0.0645 0.0015)
+(-0.0030 0.0645 0.0015)
+(0.0000 0.0645 0.0015)
+(0.0030 0.0645 0.0015)
+(0.0060 0.0645 0.0015)
+(-0.0060 0.0675 0.0015)
+(-0.0030 0.0675 0.0015)
+(0.0000 0.0675 0.0015)
+(0.0030 0.0675 0.0015)
+(0.0060 0.0675 0.0015)
+(-0.0060 0.0705 0.0015)
+(-0.0030 0.0705 0.0015)
+(0.0000 0.0705 0.0015)
+(0.0030 0.0705 0.0015)
+(0.0060 0.0705 0.0015)
+(-0.0060 0.0735 0.0015)
+(-0.0030 0.0735 0.0015)
+(0.0000 0.0735 0.0015)
+(0.0030 0.0735 0.0015)
+(0.0060 0.0735 0.0015)
+(-0.0060 -0.0735 0.0045)
+(-0.0030 -0.0735 0.0045)
+(0.0000 -0.0735 0.0045)
+(0.0030 -0.0735 0.0045)
+(0.0060 -0.0735 0.0045)
+(-0.0060 -0.0705 0.0045)
+(-0.0030 -0.0705 0.0045)
+(0.0000 -0.0705 0.0045)
+(0.0030 -0.0705 0.0045)
+(0.0060 -0.0705 0.0045)
+(-0.0060 -0.0675 0.0045)
+(-0.0030 -0.0675 0.0045)
+(0.0000 -0.0675 0.0045)
+(0.0030 -0.0675 0.0045)
+(0.0060 -0.0675 0.0045)
+(-0.0060 -0.0645 0.0045)
+(-0.0030 -0.0645 0.0045)
+(0.0000 -0.0645 0.0045)
+(0.0030 -0.0645 0.0045)
+(0.0060 -0.0645 0.0045)
+(-0.0060 -0.0615 0.0045)
+(-0.0030 -0.0615 0.0045)
+(0.0000 -0.0615 0.0045)
+(0.0030 -0.0615 0.0045)
+(0.0060 -0.0615 0.0045)
+(-0.0060 -0.0585 0.0045)
+(-0.0030 -0.0585 0.0045)
+(0.0000 -0.0585 0.0045)
+(0.0030 -0.0585 0.0045)
+(0.0060 -0.0585 0.0045)
+(-0.0060 -0.0555 0.0045)
+(-0.0030 -0.0555 0.0045)
+(0.0000 -0.0555 0.0045)
+(0.0030 -0.0555 0.0045)
+(0.0060 -0.0555 0.0045)
+(-0.0060 -0.0525 0.0045)
+(-0.0030 -0.0525 0.0045)
+(0.0000 -0.0525 0.0045)
+(0.0030 -0.0525 0.0045)
+(0.0060 -0.0525 0.0045)
+(-0.0060 -0.0495 0.0045)
+(-0.0030 -0.0495 0.0045)
+(0.0000 -0.0495 0.0045)
+(0.0030 -0.0495 0.0045)
+(0.0060 -0.0495 0.0045)
+(-0.0060 -0.0465 0.0045)
+(-0.0030 -0.0465 0.0045)
+(0.0000 -0.0465 0.0045)
+(0.0030 -0.0465 0.0045)
+(0.0060 -0.0465 0.0045)
+(-0.0060 -0.0435 0.0045)
+(-0.0030 -0.0435 0.0045)
+(0.0000 -0.0435 0.0045)
+(0.0030 -0.0435 0.0045)
+(0.0060 -0.0435 0.0045)
+(-0.0060 -0.0405 0.0045)
+(-0.0030 -0.0405 0.0045)
+(0.0000 -0.0405 0.0045)
+(0.0030 -0.0405 0.0045)
+(0.0060 -0.0405 0.0045)
+(-0.0060 -0.0375 0.0045)
+(-0.0030 -0.0375 0.0045)
+(0.0000 -0.0375 0.0045)
+(0.0030 -0.0375 0.0045)
+(0.0060 -0.0375 0.0045)
+(-0.0060 -0.0345 0.0045)
+(-0.0030 -0.0345 0.0045)
+(0.0000 -0.0345 0.0045)
+(0.0030 -0.0345 0.0045)
+(0.0060 -0.0345 0.0045)
+(-0.0060 -0.0315 0.0045)
+(-0.0030 -0.0315 0.0045)
+(0.0000 -0.0315 0.0045)
+(0.0030 -0.0315 0.0045)
+(0.0060 -0.0315 0.0045)
+(-0.0060 -0.0285 0.0045)
+(-0.0030 -0.0285 0.0045)
+(0.0000 -0.0285 0.0045)
+(0.0030 -0.0285 0.0045)
+(0.0060 -0.0285 0.0045)
+(-0.0060 -0.0255 0.0045)
+(-0.0030 -0.0255 0.0045)
+(0.0000 -0.0255 0.0045)
+(0.0030 -0.0255 0.0045)
+(0.0060 -0.0255 0.0045)
+(-0.0060 -0.0225 0.0045)
+(-0.0030 -0.0225 0.0045)
+(0.0000 -0.0225 0.0045)
+(0.0030 -0.0225 0.0045)
+(0.0060 -0.0225 0.0045)
+(-0.0060 -0.0195 0.0045)
+(-0.0030 -0.0195 0.0045)
+(0.0000 -0.0195 0.0045)
+(0.0030 -0.0195 0.0045)
+(0.0060 -0.0195 0.0045)
+(-0.0060 -0.0165 0.0045)
+(-0.0030 -0.0165 0.0045)
+(0.0000 -0.0165 0.0045)
+(0.0030 -0.0165 0.0045)
+(0.0060 -0.0165 0.0045)
+(-0.0060 -0.0135 0.0045)
+(-0.0030 -0.0135 0.0045)
+(0.0000 -0.0135 0.0045)
+(0.0030 -0.0135 0.0045)
+(0.0060 -0.0135 0.0045)
+(-0.0060 -0.0105 0.0045)
+(-0.0030 -0.0105 0.0045)
+(0.0000 -0.0105 0.0045)
+(0.0030 -0.0105 0.0045)
+(0.0060 -0.0105 0.0045)
+(-0.0060 -0.0075 0.0045)
+(-0.0030 -0.0075 0.0045)
+(0.0000 -0.0075 0.0045)
+(0.0030 -0.0075 0.0045)
+(0.0060 -0.0075 0.0045)
+(-0.0060 -0.0045 0.0045)
+(-0.0030 -0.0045 0.0045)
+(0.0000 -0.0045 0.0045)
+(0.0030 -0.0045 0.0045)
+(0.0060 -0.0045 0.0045)
+(-0.0060 -0.0015 0.0045)
+(-0.0030 -0.0015 0.0045)
+(0.0000 -0.0015 0.0045)
+(0.0030 -0.0015 0.0045)
+(0.0060 -0.0015 0.0045)
+(-0.0060 0.0015 0.0045)
+(-0.0030 0.0015 0.0045)
+(0.0000 0.0015 0.0045)
+(0.0030 0.0015 0.0045)
+(0.0060 0.0015 0.0045)
+(-0.0060 0.0045 0.0045)
+(-0.0030 0.0045 0.0045)
+(0.0000 0.0045 0.0045)
+(0.0030 0.0045 0.0045)
+(0.0060 0.0045 0.0045)
+(-0.0060 0.0075 0.0045)
+(-0.0030 0.0075 0.0045)
+(0.0000 0.0075 0.0045)
+(0.0030 0.0075 0.0045)
+(0.0060 0.0075 0.0045)
+(-0.0060 0.0105 0.0045)
+(-0.0030 0.0105 0.0045)
+(0.0000 0.0105 0.0045)
+(0.0030 0.0105 0.0045)
+(0.0060 0.0105 0.0045)
+(-0.0060 0.0135 0.0045)
+(-0.0030 0.0135 0.0045)
+(0.0000 0.0135 0.0045)
+(0.0030 0.0135 0.0045)
+(0.0060 0.0135 0.0045)
+(-0.0060 0.0165 0.0045)
+(-0.0030 0.0165 0.0045)
+(0.0000 0.0165 0.0045)
+(0.0030 0.0165 0.0045)
+(0.0060 0.0165 0.0045)
+(-0.0060 0.0195 0.0045)
+(-0.0030 0.0195 0.0045)
+(0.0000 0.0195 0.0045)
+(0.0030 0.0195 0.0045)
+(0.0060 0.0195 0.0045)
+(-0.0060 0.0225 0.0045)
+(-0.0030 0.0225 0.0045)
+(0.0000 0.0225 0.0045)
+(0.0030 0.0225 0.0045)
+(0.0060 0.0225 0.0045)
+(-0.0060 0.0255 0.0045)
+(-0.0030 0.0255 0.0045)
+(0.0000 0.0255 0.0045)
+(0.0030 0.0255 0.0045)
+(0.0060 0.0255 0.0045)
+(-0.0060 0.0285 0.0045)
+(-0.0030 0.0285 0.0045)
+(0.0000 0.0285 0.0045)
+(0.0030 0.0285 0.0045)
+(0.0060 0.0285 0.0045)
+(-0.0060 0.0315 0.0045)
+(-0.0030 0.0315 0.0045)
+(0.0000 0.0315 0.0045)
+(0.0030 0.0315 0.0045)
+(0.0060 0.0315 0.0045)
+(-0.0060 0.0345 0.0045)
+(-0.0030 0.0345 0.0045)
+(0.0000 0.0345 0.0045)
+(0.0030 0.0345 0.0045)
+(0.0060 0.0345 0.0045)
+(-0.0060 0.0375 0.0045)
+(-0.0030 0.0375 0.0045)
+(0.0000 0.0375 0.0045)
+(0.0030 0.0375 0.0045)
+(0.0060 0.0375 0.0045)
+(-0.0060 0.0405 0.0045)
+(-0.0030 0.0405 0.0045)
+(0.0000 0.0405 0.0045)
+(0.0030 0.0405 0.0045)
+(0.0060 0.0405 0.0045)
+(-0.0060 0.0435 0.0045)
+(-0.0030 0.0435 0.0045)
+(0.0000 0.0435 0.0045)
+(0.0030 0.0435 0.0045)
+(0.0060 0.0435 0.0045)
+(-0.0060 0.0465 0.0045)
+(-0.0030 0.0465 0.0045)
+(0.0000 0.0465 0.0045)
+(0.0030 0.0465 0.0045)
+(0.0060 0.0465 0.0045)
+(-0.0060 0.0495 0.0045)
+(-0.0030 0.0495 0.0045)
+(0.0000 0.0495 0.0045)
+(0.0030 0.0495 0.0045)
+(0.0060 0.0495 0.0045)
+(-0.0060 0.0525 0.0045)
+(-0.0030 0.0525 0.0045)
+(0.0000 0.0525 0.0045)
+(0.0030 0.0525 0.0045)
+(0.0060 0.0525 0.0045)
+(-0.0060 0.0555 0.0045)
+(-0.0030 0.0555 0.0045)
+(0.0000 0.0555 0.0045)
+(0.0030 0.0555 0.0045)
+(0.0060 0.0555 0.0045)
+(-0.0060 0.0585 0.0045)
+(-0.0030 0.0585 0.0045)
+(0.0000 0.0585 0.0045)
+(0.0030 0.0585 0.0045)
+(0.0060 0.0585 0.0045)
+(-0.0060 0.0615 0.0045)
+(-0.0030 0.0615 0.0045)
+(0.0000 0.0615 0.0045)
+(0.0030 0.0615 0.0045)
+(0.0060 0.0615 0.0045)
+(-0.0060 0.0645 0.0045)
+(-0.0030 0.0645 0.0045)
+(0.0000 0.0645 0.0045)
+(0.0030 0.0645 0.0045)
+(0.0060 0.0645 0.0045)
+(-0.0060 0.0675 0.0045)
+(-0.0030 0.0675 0.0045)
+(0.0000 0.0675 0.0045)
+(0.0030 0.0675 0.0045)
+(0.0060 0.0675 0.0045)
+(-0.0060 0.0705 0.0045)
+(-0.0030 0.0705 0.0045)
+(0.0000 0.0705 0.0045)
+(0.0030 0.0705 0.0045)
+(0.0060 0.0705 0.0045)
+(-0.0060 0.0735 0.0045)
+(-0.0030 0.0735 0.0045)
+(0.0000 0.0735 0.0045)
+(0.0030 0.0735 0.0045)
+(0.0060 0.0735 0.0045)
+(-0.0060 -0.0735 0.0075)
+(-0.0030 -0.0735 0.0075)
+(0.0000 -0.0735 0.0075)
+(0.0030 -0.0735 0.0075)
+(0.0060 -0.0735 0.0075)
+(-0.0060 -0.0705 0.0075)
+(-0.0030 -0.0705 0.0075)
+(0.0000 -0.0705 0.0075)
+(0.0030 -0.0705 0.0075)
+(0.0060 -0.0705 0.0075)
+(-0.0060 -0.0675 0.0075)
+(-0.0030 -0.0675 0.0075)
+(0.0000 -0.0675 0.0075)
+(0.0030 -0.0675 0.0075)
+(0.0060 -0.0675 0.0075)
+(-0.0060 -0.0645 0.0075)
+(-0.0030 -0.0645 0.0075)
+(0.0000 -0.0645 0.0075)
+(0.0030 -0.0645 0.0075)
+(0.0060 -0.0645 0.0075)
+(-0.0060 -0.0615 0.0075)
+(-0.0030 -0.0615 0.0075)
+(0.0000 -0.0615 0.0075)
+(0.0030 -0.0615 0.0075)
+(0.0060 -0.0615 0.0075)
+(-0.0060 -0.0585 0.0075)
+(-0.0030 -0.0585 0.0075)
+(0.0000 -0.0585 0.0075)
+(0.0030 -0.0585 0.0075)
+(0.0060 -0.0585 0.0075)
+(-0.0060 -0.0555 0.0075)
+(-0.0030 -0.0555 0.0075)
+(0.0000 -0.0555 0.0075)
+(0.0030 -0.0555 0.0075)
+(0.0060 -0.0555 0.0075)
+(-0.0060 -0.0525 0.0075)
+(-0.0030 -0.0525 0.0075)
+(0.0000 -0.0525 0.0075)
+(0.0030 -0.0525 0.0075)
+(0.0060 -0.0525 0.0075)
+(-0.0060 -0.0495 0.0075)
+(-0.0030 -0.0495 0.0075)
+(0.0000 -0.0495 0.0075)
+(0.0030 -0.0495 0.0075)
+(0.0060 -0.0495 0.0075)
+(-0.0060 -0.0465 0.0075)
+(-0.0030 -0.0465 0.0075)
+(0.0000 -0.0465 0.0075)
+(0.0030 -0.0465 0.0075)
+(0.0060 -0.0465 0.0075)
+(-0.0060 -0.0435 0.0075)
+(-0.0030 -0.0435 0.0075)
+(0.0000 -0.0435 0.0075)
+(0.0030 -0.0435 0.0075)
+(0.0060 -0.0435 0.0075)
+(-0.0060 -0.0405 0.0075)
+(-0.0030 -0.0405 0.0075)
+(0.0000 -0.0405 0.0075)
+(0.0030 -0.0405 0.0075)
+(0.0060 -0.0405 0.0075)
+(-0.0060 -0.0375 0.0075)
+(-0.0030 -0.0375 0.0075)
+(0.0000 -0.0375 0.0075)
+(0.0030 -0.0375 0.0075)
+(0.0060 -0.0375 0.0075)
+(-0.0060 -0.0345 0.0075)
+(-0.0030 -0.0345 0.0075)
+(0.0000 -0.0345 0.0075)
+(0.0030 -0.0345 0.0075)
+(0.0060 -0.0345 0.0075)
+(-0.0060 -0.0315 0.0075)
+(-0.0030 -0.0315 0.0075)
+(0.0000 -0.0315 0.0075)
+(0.0030 -0.0315 0.0075)
+(0.0060 -0.0315 0.0075)
+(-0.0060 -0.0285 0.0075)
+(-0.0030 -0.0285 0.0075)
+(0.0000 -0.0285 0.0075)
+(0.0030 -0.0285 0.0075)
+(0.0060 -0.0285 0.0075)
+(-0.0060 -0.0255 0.0075)
+(-0.0030 -0.0255 0.0075)
+(0.0000 -0.0255 0.0075)
+(0.0030 -0.0255 0.0075)
+(0.0060 -0.0255 0.0075)
+(-0.0060 -0.0225 0.0075)
+(-0.0030 -0.0225 0.0075)
+(0.0000 -0.0225 0.0075)
+(0.0030 -0.0225 0.0075)
+(0.0060 -0.0225 0.0075)
+(-0.0060 -0.0195 0.0075)
+(-0.0030 -0.0195 0.0075)
+(0.0000 -0.0195 0.0075)
+(0.0030 -0.0195 0.0075)
+(0.0060 -0.0195 0.0075)
+(-0.0060 -0.0165 0.0075)
+(-0.0030 -0.0165 0.0075)
+(0.0000 -0.0165 0.0075)
+(0.0030 -0.0165 0.0075)
+(0.0060 -0.0165 0.0075)
+(-0.0060 -0.0135 0.0075)
+(-0.0030 -0.0135 0.0075)
+(0.0000 -0.0135 0.0075)
+(0.0030 -0.0135 0.0075)
+(0.0060 -0.0135 0.0075)
+(-0.0060 -0.0105 0.0075)
+(-0.0030 -0.0105 0.0075)
+(0.0000 -0.0105 0.0075)
+(0.0030 -0.0105 0.0075)
+(0.0060 -0.0105 0.0075)
+(-0.0060 -0.0075 0.0075)
+(-0.0030 -0.0075 0.0075)
+(0.0000 -0.0075 0.0075)
+(0.0030 -0.0075 0.0075)
+(0.0060 -0.0075 0.0075)
+(-0.0060 -0.0045 0.0075)
+(-0.0030 -0.0045 0.0075)
+(0.0000 -0.0045 0.0075)
+(0.0030 -0.0045 0.0075)
+(0.0060 -0.0045 0.0075)
+(-0.0060 -0.0015 0.0075)
+(-0.0030 -0.0015 0.0075)
+(0.0000 -0.0015 0.0075)
+(0.0030 -0.0015 0.0075)
+(0.0060 -0.0015 0.0075)
+(-0.0060 0.0015 0.0075)
+(-0.0030 0.0015 0.0075)
+(0.0000 0.0015 0.0075)
+(0.0030 0.0015 0.0075)
+(0.0060 0.0015 0.0075)
+(-0.0060 0.0045 0.0075)
+(-0.0030 0.0045 0.0075)
+(0.0000 0.0045 0.0075)
+(0.0030 0.0045 0.0075)
+(0.0060 0.0045 0.0075)
+(-0.0060 0.0075 0.0075)
+(-0.0030 0.0075 0.0075)
+(0.0000 0.0075 0.0075)
+(0.0030 0.0075 0.0075)
+(0.0060 0.0075 0.0075)
+(-0.0060 0.0105 0.0075)
+(-0.0030 0.0105 0.0075)
+(0.0000 0.0105 0.0075)
+(0.0030 0.0105 0.0075)
+(0.0060 0.0105 0.0075)
+(-0.0060 0.0135 0.0075)
+(-0.0030 0.0135 0.0075)
+(0.0000 0.0135 0.0075)
+(0.0030 0.0135 0.0075)
+(0.0060 0.0135 0.0075)
+(-0.0060 0.0165 0.0075)
+(-0.0030 0.0165 0.0075)
+(0.0000 0.0165 0.0075)
+(0.0030 0.0165 0.0075)
+(0.0060 0.0165 0.0075)
+(-0.0060 0.0195 0.0075)
+(-0.0030 0.0195 0.0075)
+(0.0000 0.0195 0.0075)
+(0.0030 0.0195 0.0075)
+(0.0060 0.0195 0.0075)
+(-0.0060 0.0225 0.0075)
+(-0.0030 0.0225 0.0075)
+(0.0000 0.0225 0.0075)
+(0.0030 0.0225 0.0075)
+(0.0060 0.0225 0.0075)
+(-0.0060 0.0255 0.0075)
+(-0.0030 0.0255 0.0075)
+(0.0000 0.0255 0.0075)
+(0.0030 0.0255 0.0075)
+(0.0060 0.0255 0.0075)
+(-0.0060 0.0285 0.0075)
+(-0.0030 0.0285 0.0075)
+(0.0000 0.0285 0.0075)
+(0.0030 0.0285 0.0075)
+(0.0060 0.0285 0.0075)
+(-0.0060 0.0315 0.0075)
+(-0.0030 0.0315 0.0075)
+(0.0000 0.0315 0.0075)
+(0.0030 0.0315 0.0075)
+(0.0060 0.0315 0.0075)
+(-0.0060 0.0345 0.0075)
+(-0.0030 0.0345 0.0075)
+(0.0000 0.0345 0.0075)
+(0.0030 0.0345 0.0075)
+(0.0060 0.0345 0.0075)
+(-0.0060 0.0375 0.0075)
+(-0.0030 0.0375 0.0075)
+(0.0000 0.0375 0.0075)
+(0.0030 0.0375 0.0075)
+(0.0060 0.0375 0.0075)
+(-0.0060 0.0405 0.0075)
+(-0.0030 0.0405 0.0075)
+(0.0000 0.0405 0.0075)
+(0.0030 0.0405 0.0075)
+(0.0060 0.0405 0.0075)
+(-0.0060 0.0435 0.0075)
+(-0.0030 0.0435 0.0075)
+(0.0000 0.0435 0.0075)
+(0.0030 0.0435 0.0075)
+(0.0060 0.0435 0.0075)
+(-0.0060 0.0465 0.0075)
+(-0.0030 0.0465 0.0075)
+(0.0000 0.0465 0.0075)
+(0.0030 0.0465 0.0075)
+(0.0060 0.0465 0.0075)
+(-0.0060 0.0495 0.0075)
+(-0.0030 0.0495 0.0075)
+(0.0000 0.0495 0.0075)
+(0.0030 0.0495 0.0075)
+(0.0060 0.0495 0.0075)
+(-0.0060 0.0525 0.0075)
+(-0.0030 0.0525 0.0075)
+(0.0000 0.0525 0.0075)
+(0.0030 0.0525 0.0075)
+(0.0060 0.0525 0.0075)
+(-0.0060 0.0555 0.0075)
+(-0.0030 0.0555 0.0075)
+(0.0000 0.0555 0.0075)
+(0.0030 0.0555 0.0075)
+(0.0060 0.0555 0.0075)
+(-0.0060 0.0585 0.0075)
+(-0.0030 0.0585 0.0075)
+(0.0000 0.0585 0.0075)
+(0.0030 0.0585 0.0075)
+(0.0060 0.0585 0.0075)
+(-0.0060 0.0615 0.0075)
+(-0.0030 0.0615 0.0075)
+(0.0000 0.0615 0.0075)
+(0.0030 0.0615 0.0075)
+(0.0060 0.0615 0.0075)
+(-0.0060 0.0645 0.0075)
+(-0.0030 0.0645 0.0075)
+(0.0000 0.0645 0.0075)
+(0.0030 0.0645 0.0075)
+(0.0060 0.0645 0.0075)
+(-0.0060 0.0675 0.0075)
+(-0.0030 0.0675 0.0075)
+(0.0000 0.0675 0.0075)
+(0.0030 0.0675 0.0075)
+(0.0060 0.0675 0.0075)
+(-0.0060 0.0705 0.0075)
+(-0.0030 0.0705 0.0075)
+(0.0000 0.0705 0.0075)
+(0.0030 0.0705 0.0075)
+(0.0060 0.0705 0.0075)
+(-0.0060 0.0735 0.0075)
+(-0.0030 0.0735 0.0075)
+(0.0000 0.0735 0.0075)
+(0.0030 0.0735 0.0075)
+(0.0060 0.0735 0.0075)
+(-0.0060 -0.0735 0.0105)
+(-0.0030 -0.0735 0.0105)
+(0.0000 -0.0735 0.0105)
+(0.0030 -0.0735 0.0105)
+(0.0060 -0.0735 0.0105)
+(-0.0060 -0.0705 0.0105)
+(-0.0030 -0.0705 0.0105)
+(0.0000 -0.0705 0.0105)
+(0.0030 -0.0705 0.0105)
+(0.0060 -0.0705 0.0105)
+(-0.0060 -0.0675 0.0105)
+(-0.0030 -0.0675 0.0105)
+(0.0000 -0.0675 0.0105)
+(0.0030 -0.0675 0.0105)
+(0.0060 -0.0675 0.0105)
+(-0.0060 -0.0645 0.0105)
+(-0.0030 -0.0645 0.0105)
+(0.0000 -0.0645 0.0105)
+(0.0030 -0.0645 0.0105)
+(0.0060 -0.0645 0.0105)
+(-0.0060 -0.0615 0.0105)
+(-0.0030 -0.0615 0.0105)
+(0.0000 -0.0615 0.0105)
+(0.0030 -0.0615 0.0105)
+(0.0060 -0.0615 0.0105)
+(-0.0060 -0.0585 0.0105)
+(-0.0030 -0.0585 0.0105)
+(0.0000 -0.0585 0.0105)
+(0.0030 -0.0585 0.0105)
+(0.0060 -0.0585 0.0105)
+(-0.0060 -0.0555 0.0105)
+(-0.0030 -0.0555 0.0105)
+(0.0000 -0.0555 0.0105)
+(0.0030 -0.0555 0.0105)
+(0.0060 -0.0555 0.0105)
+(-0.0060 -0.0525 0.0105)
+(-0.0030 -0.0525 0.0105)
+(0.0000 -0.0525 0.0105)
+(0.0030 -0.0525 0.0105)
+(0.0060 -0.0525 0.0105)
+(-0.0060 -0.0495 0.0105)
+(-0.0030 -0.0495 0.0105)
+(0.0000 -0.0495 0.0105)
+(0.0030 -0.0495 0.0105)
+(0.0060 -0.0495 0.0105)
+(-0.0060 -0.0465 0.0105)
+(-0.0030 -0.0465 0.0105)
+(0.0000 -0.0465 0.0105)
+(0.0030 -0.0465 0.0105)
+(0.0060 -0.0465 0.0105)
+(-0.0060 -0.0435 0.0105)
+(-0.0030 -0.0435 0.0105)
+(0.0000 -0.0435 0.0105)
+(0.0030 -0.0435 0.0105)
+(0.0060 -0.0435 0.0105)
+(-0.0060 -0.0405 0.0105)
+(-0.0030 -0.0405 0.0105)
+(0.0000 -0.0405 0.0105)
+(0.0030 -0.0405 0.0105)
+(0.0060 -0.0405 0.0105)
+(-0.0060 -0.0375 0.0105)
+(-0.0030 -0.0375 0.0105)
+(0.0000 -0.0375 0.0105)
+(0.0030 -0.0375 0.0105)
+(0.0060 -0.0375 0.0105)
+(-0.0060 -0.0345 0.0105)
+(-0.0030 -0.0345 0.0105)
+(0.0000 -0.0345 0.0105)
+(0.0030 -0.0345 0.0105)
+(0.0060 -0.0345 0.0105)
+(-0.0060 -0.0315 0.0105)
+(-0.0030 -0.0315 0.0105)
+(0.0000 -0.0315 0.0105)
+(0.0030 -0.0315 0.0105)
+(0.0060 -0.0315 0.0105)
+(-0.0060 -0.0285 0.0105)
+(-0.0030 -0.0285 0.0105)
+(0.0000 -0.0285 0.0105)
+(0.0030 -0.0285 0.0105)
+(0.0060 -0.0285 0.0105)
+(-0.0060 -0.0255 0.0105)
+(-0.0030 -0.0255 0.0105)
+(0.0000 -0.0255 0.0105)
+(0.0030 -0.0255 0.0105)
+(0.0060 -0.0255 0.0105)
+(-0.0060 -0.0225 0.0105)
+(-0.0030 -0.0225 0.0105)
+(0.0000 -0.0225 0.0105)
+(0.0030 -0.0225 0.0105)
+(0.0060 -0.0225 0.0105)
+(-0.0060 -0.0195 0.0105)
+(-0.0030 -0.0195 0.0105)
+(0.0000 -0.0195 0.0105)
+(0.0030 -0.0195 0.0105)
+(0.0060 -0.0195 0.0105)
+(-0.0060 -0.0165 0.0105)
+(-0.0030 -0.0165 0.0105)
+(0.0000 -0.0165 0.0105)
+(0.0030 -0.0165 0.0105)
+(0.0060 -0.0165 0.0105)
+(-0.0060 -0.0135 0.0105)
+(-0.0030 -0.0135 0.0105)
+(0.0000 -0.0135 0.0105)
+(0.0030 -0.0135 0.0105)
+(0.0060 -0.0135 0.0105)
+(-0.0060 -0.0105 0.0105)
+(-0.0030 -0.0105 0.0105)
+(0.0000 -0.0105 0.0105)
+(0.0030 -0.0105 0.0105)
+(0.0060 -0.0105 0.0105)
+(-0.0060 -0.0075 0.0105)
+(-0.0030 -0.0075 0.0105)
+(0.0000 -0.0075 0.0105)
+(0.0030 -0.0075 0.0105)
+(0.0060 -0.0075 0.0105)
+(-0.0060 -0.0045 0.0105)
+(-0.0030 -0.0045 0.0105)
+(0.0000 -0.0045 0.0105)
+(0.0030 -0.0045 0.0105)
+(0.0060 -0.0045 0.0105)
+(-0.0060 -0.0015 0.0105)
+(-0.0030 -0.0015 0.0105)
+(0.0000 -0.0015 0.0105)
+(0.0030 -0.0015 0.0105)
+(0.0060 -0.0015 0.0105)
+(-0.0060 0.0015 0.0105)
+(-0.0030 0.0015 0.0105)
+(0.0000 0.0015 0.0105)
+(0.0030 0.0015 0.0105)
+(0.0060 0.0015 0.0105)
+(-0.0060 0.0045 0.0105)
+(-0.0030 0.0045 0.0105)
+(0.0000 0.0045 0.0105)
+(0.0030 0.0045 0.0105)
+(0.0060 0.0045 0.0105)
+(-0.0060 0.0075 0.0105)
+(-0.0030 0.0075 0.0105)
+(0.0000 0.0075 0.0105)
+(0.0030 0.0075 0.0105)
+(0.0060 0.0075 0.0105)
+(-0.0060 0.0105 0.0105)
+(-0.0030 0.0105 0.0105)
+(0.0000 0.0105 0.0105)
+(0.0030 0.0105 0.0105)
+(0.0060 0.0105 0.0105)
+(-0.0060 0.0135 0.0105)
+(-0.0030 0.0135 0.0105)
+(0.0000 0.0135 0.0105)
+(0.0030 0.0135 0.0105)
+(0.0060 0.0135 0.0105)
+(-0.0060 0.0165 0.0105)
+(-0.0030 0.0165 0.0105)
+(0.0000 0.0165 0.0105)
+(0.0030 0.0165 0.0105)
+(0.0060 0.0165 0.0105)
+(-0.0060 0.0195 0.0105)
+(-0.0030 0.0195 0.0105)
+(0.0000 0.0195 0.0105)
+(0.0030 0.0195 0.0105)
+(0.0060 0.0195 0.0105)
+(-0.0060 0.0225 0.0105)
+(-0.0030 0.0225 0.0105)
+(0.0000 0.0225 0.0105)
+(0.0030 0.0225 0.0105)
+(0.0060 0.0225 0.0105)
+(-0.0060 0.0255 0.0105)
+(-0.0030 0.0255 0.0105)
+(0.0000 0.0255 0.0105)
+(0.0030 0.0255 0.0105)
+(0.0060 0.0255 0.0105)
+(-0.0060 0.0285 0.0105)
+(-0.0030 0.0285 0.0105)
+(0.0000 0.0285 0.0105)
+(0.0030 0.0285 0.0105)
+(0.0060 0.0285 0.0105)
+(-0.0060 0.0315 0.0105)
+(-0.0030 0.0315 0.0105)
+(0.0000 0.0315 0.0105)
+(0.0030 0.0315 0.0105)
+(0.0060 0.0315 0.0105)
+(-0.0060 0.0345 0.0105)
+(-0.0030 0.0345 0.0105)
+(0.0000 0.0345 0.0105)
+(0.0030 0.0345 0.0105)
+(0.0060 0.0345 0.0105)
+(-0.0060 0.0375 0.0105)
+(-0.0030 0.0375 0.0105)
+(0.0000 0.0375 0.0105)
+(0.0030 0.0375 0.0105)
+(0.0060 0.0375 0.0105)
+(-0.0060 0.0405 0.0105)
+(-0.0030 0.0405 0.0105)
+(0.0000 0.0405 0.0105)
+(0.0030 0.0405 0.0105)
+(0.0060 0.0405 0.0105)
+(-0.0060 0.0435 0.0105)
+(-0.0030 0.0435 0.0105)
+(0.0000 0.0435 0.0105)
+(0.0030 0.0435 0.0105)
+(0.0060 0.0435 0.0105)
+(-0.0060 0.0465 0.0105)
+(-0.0030 0.0465 0.0105)
+(0.0000 0.0465 0.0105)
+(0.0030 0.0465 0.0105)
+(0.0060 0.0465 0.0105)
+(-0.0060 0.0495 0.0105)
+(-0.0030 0.0495 0.0105)
+(0.0000 0.0495 0.0105)
+(0.0030 0.0495 0.0105)
+(0.0060 0.0495 0.0105)
+(-0.0060 0.0525 0.0105)
+(-0.0030 0.0525 0.0105)
+(0.0000 0.0525 0.0105)
+(0.0030 0.0525 0.0105)
+(0.0060 0.0525 0.0105)
+(-0.0060 0.0555 0.0105)
+(-0.0030 0.0555 0.0105)
+(0.0000 0.0555 0.0105)
+(0.0030 0.0555 0.0105)
+(0.0060 0.0555 0.0105)
+(-0.0060 0.0585 0.0105)
+(-0.0030 0.0585 0.0105)
+(0.0000 0.0585 0.0105)
+(0.0030 0.0585 0.0105)
+(0.0060 0.0585 0.0105)
+(-0.0060 0.0615 0.0105)
+(-0.0030 0.0615 0.0105)
+(0.0000 0.0615 0.0105)
+(0.0030 0.0615 0.0105)
+(0.0060 0.0615 0.0105)
+(-0.0060 0.0645 0.0105)
+(-0.0030 0.0645 0.0105)
+(0.0000 0.0645 0.0105)
+(0.0030 0.0645 0.0105)
+(0.0060 0.0645 0.0105)
+(-0.0060 0.0675 0.0105)
+(-0.0030 0.0675 0.0105)
+(0.0000 0.0675 0.0105)
+(0.0030 0.0675 0.0105)
+(0.0060 0.0675 0.0105)
+(-0.0060 0.0705 0.0105)
+(-0.0030 0.0705 0.0105)
+(0.0000 0.0705 0.0105)
+(0.0030 0.0705 0.0105)
+(0.0060 0.0705 0.0105)
+(-0.0060 0.0735 0.0105)
+(-0.0030 0.0735 0.0105)
+(0.0000 0.0735 0.0105)
+(0.0030 0.0735 0.0105)
+(0.0060 0.0735 0.0105)
+(-0.0060 -0.0735 0.0135)
+(-0.0030 -0.0735 0.0135)
+(0.0000 -0.0735 0.0135)
+(0.0030 -0.0735 0.0135)
+(0.0060 -0.0735 0.0135)
+(-0.0060 -0.0705 0.0135)
+(-0.0030 -0.0705 0.0135)
+(0.0000 -0.0705 0.0135)
+(0.0030 -0.0705 0.0135)
+(0.0060 -0.0705 0.0135)
+(-0.0060 -0.0675 0.0135)
+(-0.0030 -0.0675 0.0135)
+(0.0000 -0.0675 0.0135)
+(0.0030 -0.0675 0.0135)
+(0.0060 -0.0675 0.0135)
+(-0.0060 -0.0645 0.0135)
+(-0.0030 -0.0645 0.0135)
+(0.0000 -0.0645 0.0135)
+(0.0030 -0.0645 0.0135)
+(0.0060 -0.0645 0.0135)
+(-0.0060 -0.0615 0.0135)
+(-0.0030 -0.0615 0.0135)
+(0.0000 -0.0615 0.0135)
+(0.0030 -0.0615 0.0135)
+(0.0060 -0.0615 0.0135)
+(-0.0060 -0.0585 0.0135)
+(-0.0030 -0.0585 0.0135)
+(0.0000 -0.0585 0.0135)
+(0.0030 -0.0585 0.0135)
+(0.0060 -0.0585 0.0135)
+(-0.0060 -0.0555 0.0135)
+(-0.0030 -0.0555 0.0135)
+(0.0000 -0.0555 0.0135)
+(0.0030 -0.0555 0.0135)
+(0.0060 -0.0555 0.0135)
+(-0.0060 -0.0525 0.0135)
+(-0.0030 -0.0525 0.0135)
+(0.0000 -0.0525 0.0135)
+(0.0030 -0.0525 0.0135)
+(0.0060 -0.0525 0.0135)
+(-0.0060 -0.0495 0.0135)
+(-0.0030 -0.0495 0.0135)
+(0.0000 -0.0495 0.0135)
+(0.0030 -0.0495 0.0135)
+(0.0060 -0.0495 0.0135)
+(-0.0060 -0.0465 0.0135)
+(-0.0030 -0.0465 0.0135)
+(0.0000 -0.0465 0.0135)
+(0.0030 -0.0465 0.0135)
+(0.0060 -0.0465 0.0135)
+(-0.0060 -0.0435 0.0135)
+(-0.0030 -0.0435 0.0135)
+(0.0000 -0.0435 0.0135)
+(0.0030 -0.0435 0.0135)
+(0.0060 -0.0435 0.0135)
+(-0.0060 -0.0405 0.0135)
+(-0.0030 -0.0405 0.0135)
+(0.0000 -0.0405 0.0135)
+(0.0030 -0.0405 0.0135)
+(0.0060 -0.0405 0.0135)
+(-0.0060 -0.0375 0.0135)
+(-0.0030 -0.0375 0.0135)
+(0.0000 -0.0375 0.0135)
+(0.0030 -0.0375 0.0135)
+(0.0060 -0.0375 0.0135)
+(-0.0060 -0.0345 0.0135)
+(-0.0030 -0.0345 0.0135)
+(0.0000 -0.0345 0.0135)
+(0.0030 -0.0345 0.0135)
+(0.0060 -0.0345 0.0135)
+(-0.0060 -0.0315 0.0135)
+(-0.0030 -0.0315 0.0135)
+(0.0000 -0.0315 0.0135)
+(0.0030 -0.0315 0.0135)
+(0.0060 -0.0315 0.0135)
+(-0.0060 -0.0285 0.0135)
+(-0.0030 -0.0285 0.0135)
+(0.0000 -0.0285 0.0135)
+(0.0030 -0.0285 0.0135)
+(0.0060 -0.0285 0.0135)
+(-0.0060 -0.0255 0.0135)
+(-0.0030 -0.0255 0.0135)
+(0.0000 -0.0255 0.0135)
+(0.0030 -0.0255 0.0135)
+(0.0060 -0.0255 0.0135)
+(-0.0060 -0.0225 0.0135)
+(-0.0030 -0.0225 0.0135)
+(0.0000 -0.0225 0.0135)
+(0.0030 -0.0225 0.0135)
+(0.0060 -0.0225 0.0135)
+(-0.0060 -0.0195 0.0135)
+(-0.0030 -0.0195 0.0135)
+(0.0000 -0.0195 0.0135)
+(0.0030 -0.0195 0.0135)
+(0.0060 -0.0195 0.0135)
+(-0.0060 -0.0165 0.0135)
+(-0.0030 -0.0165 0.0135)
+(0.0000 -0.0165 0.0135)
+(0.0030 -0.0165 0.0135)
+(0.0060 -0.0165 0.0135)
+(-0.0060 -0.0135 0.0135)
+(-0.0030 -0.0135 0.0135)
+(0.0000 -0.0135 0.0135)
+(0.0030 -0.0135 0.0135)
+(0.0060 -0.0135 0.0135)
+(-0.0060 -0.0105 0.0135)
+(-0.0030 -0.0105 0.0135)
+(0.0000 -0.0105 0.0135)
+(0.0030 -0.0105 0.0135)
+(0.0060 -0.0105 0.0135)
+(-0.0060 -0.0075 0.0135)
+(-0.0030 -0.0075 0.0135)
+(0.0000 -0.0075 0.0135)
+(0.0030 -0.0075 0.0135)
+(0.0060 -0.0075 0.0135)
+(-0.0060 -0.0045 0.0135)
+(-0.0030 -0.0045 0.0135)
+(0.0000 -0.0045 0.0135)
+(0.0030 -0.0045 0.0135)
+(0.0060 -0.0045 0.0135)
+(-0.0060 -0.0015 0.0135)
+(-0.0030 -0.0015 0.0135)
+(0.0000 -0.0015 0.0135)
+(0.0030 -0.0015 0.0135)
+(0.0060 -0.0015 0.0135)
+(-0.0060 0.0015 0.0135)
+(-0.0030 0.0015 0.0135)
+(0.0000 0.0015 0.0135)
+(0.0030 0.0015 0.0135)
+(0.0060 0.0015 0.0135)
+(-0.0060 0.0045 0.0135)
+(-0.0030 0.0045 0.0135)
+(0.0000 0.0045 0.0135)
+(0.0030 0.0045 0.0135)
+(0.0060 0.0045 0.0135)
+(-0.0060 0.0075 0.0135)
+(-0.0030 0.0075 0.0135)
+(0.0000 0.0075 0.0135)
+(0.0030 0.0075 0.0135)
+(0.0060 0.0075 0.0135)
+(-0.0060 0.0105 0.0135)
+(-0.0030 0.0105 0.0135)
+(0.0000 0.0105 0.0135)
+(0.0030 0.0105 0.0135)
+(0.0060 0.0105 0.0135)
+(-0.0060 0.0135 0.0135)
+(-0.0030 0.0135 0.0135)
+(0.0000 0.0135 0.0135)
+(0.0030 0.0135 0.0135)
+(0.0060 0.0135 0.0135)
+(-0.0060 0.0165 0.0135)
+(-0.0030 0.0165 0.0135)
+(0.0000 0.0165 0.0135)
+(0.0030 0.0165 0.0135)
+(0.0060 0.0165 0.0135)
+(-0.0060 0.0195 0.0135)
+(-0.0030 0.0195 0.0135)
+(0.0000 0.0195 0.0135)
+(0.0030 0.0195 0.0135)
+(0.0060 0.0195 0.0135)
+(-0.0060 0.0225 0.0135)
+(-0.0030 0.0225 0.0135)
+(0.0000 0.0225 0.0135)
+(0.0030 0.0225 0.0135)
+(0.0060 0.0225 0.0135)
+(-0.0060 0.0255 0.0135)
+(-0.0030 0.0255 0.0135)
+(0.0000 0.0255 0.0135)
+(0.0030 0.0255 0.0135)
+(0.0060 0.0255 0.0135)
+(-0.0060 0.0285 0.0135)
+(-0.0030 0.0285 0.0135)
+(0.0000 0.0285 0.0135)
+(0.0030 0.0285 0.0135)
+(0.0060 0.0285 0.0135)
+(-0.0060 0.0315 0.0135)
+(-0.0030 0.0315 0.0135)
+(0.0000 0.0315 0.0135)
+(0.0030 0.0315 0.0135)
+(0.0060 0.0315 0.0135)
+(-0.0060 0.0345 0.0135)
+(-0.0030 0.0345 0.0135)
+(0.0000 0.0345 0.0135)
+(0.0030 0.0345 0.0135)
+(0.0060 0.0345 0.0135)
+(-0.0060 0.0375 0.0135)
+(-0.0030 0.0375 0.0135)
+(0.0000 0.0375 0.0135)
+(0.0030 0.0375 0.0135)
+(0.0060 0.0375 0.0135)
+(-0.0060 0.0405 0.0135)
+(-0.0030 0.0405 0.0135)
+(0.0000 0.0405 0.0135)
+(0.0030 0.0405 0.0135)
+(0.0060 0.0405 0.0135)
+(-0.0060 0.0435 0.0135)
+(-0.0030 0.0435 0.0135)
+(0.0000 0.0435 0.0135)
+(0.0030 0.0435 0.0135)
+(0.0060 0.0435 0.0135)
+(-0.0060 0.0465 0.0135)
+(-0.0030 0.0465 0.0135)
+(0.0000 0.0465 0.0135)
+(0.0030 0.0465 0.0135)
+(0.0060 0.0465 0.0135)
+(-0.0060 0.0495 0.0135)
+(-0.0030 0.0495 0.0135)
+(0.0000 0.0495 0.0135)
+(0.0030 0.0495 0.0135)
+(0.0060 0.0495 0.0135)
+(-0.0060 0.0525 0.0135)
+(-0.0030 0.0525 0.0135)
+(0.0000 0.0525 0.0135)
+(0.0030 0.0525 0.0135)
+(0.0060 0.0525 0.0135)
+(-0.0060 0.0555 0.0135)
+(-0.0030 0.0555 0.0135)
+(0.0000 0.0555 0.0135)
+(0.0030 0.0555 0.0135)
+(0.0060 0.0555 0.0135)
+(-0.0060 0.0585 0.0135)
+(-0.0030 0.0585 0.0135)
+(0.0000 0.0585 0.0135)
+(0.0030 0.0585 0.0135)
+(0.0060 0.0585 0.0135)
+(-0.0060 0.0615 0.0135)
+(-0.0030 0.0615 0.0135)
+(0.0000 0.0615 0.0135)
+(0.0030 0.0615 0.0135)
+(0.0060 0.0615 0.0135)
+(-0.0060 0.0645 0.0135)
+(-0.0030 0.0645 0.0135)
+(0.0000 0.0645 0.0135)
+(0.0030 0.0645 0.0135)
+(0.0060 0.0645 0.0135)
+(-0.0060 0.0675 0.0135)
+(-0.0030 0.0675 0.0135)
+(0.0000 0.0675 0.0135)
+(0.0030 0.0675 0.0135)
+(0.0060 0.0675 0.0135)
+(-0.0060 0.0705 0.0135)
+(-0.0030 0.0705 0.0135)
+(0.0000 0.0705 0.0135)
+(0.0030 0.0705 0.0135)
+(0.0060 0.0705 0.0135)
+(-0.0060 0.0735 0.0135)
+(-0.0030 0.0735 0.0135)
+(0.0000 0.0735 0.0135)
+(0.0030 0.0735 0.0135)
+(0.0060 0.0735 0.0135)
+(-0.0060 -0.0735 0.0165)
+(-0.0030 -0.0735 0.0165)
+(0.0000 -0.0735 0.0165)
+(0.0030 -0.0735 0.0165)
+(0.0060 -0.0735 0.0165)
+(-0.0060 -0.0705 0.0165)
+(-0.0030 -0.0705 0.0165)
+(0.0000 -0.0705 0.0165)
+(0.0030 -0.0705 0.0165)
+(0.0060 -0.0705 0.0165)
+(-0.0060 -0.0675 0.0165)
+(-0.0030 -0.0675 0.0165)
+(0.0000 -0.0675 0.0165)
+(0.0030 -0.0675 0.0165)
+(0.0060 -0.0675 0.0165)
+(-0.0060 -0.0645 0.0165)
+(-0.0030 -0.0645 0.0165)
+(0.0000 -0.0645 0.0165)
+(0.0030 -0.0645 0.0165)
+(0.0060 -0.0645 0.0165)
+(-0.0060 -0.0615 0.0165)
+(-0.0030 -0.0615 0.0165)
+(0.0000 -0.0615 0.0165)
+(0.0030 -0.0615 0.0165)
+(0.0060 -0.0615 0.0165)
+(-0.0060 -0.0585 0.0165)
+(-0.0030 -0.0585 0.0165)
+(0.0000 -0.0585 0.0165)
+(0.0030 -0.0585 0.0165)
+(0.0060 -0.0585 0.0165)
+(-0.0060 -0.0555 0.0165)
+(-0.0030 -0.0555 0.0165)
+(0.0000 -0.0555 0.0165)
+(0.0030 -0.0555 0.0165)
+(0.0060 -0.0555 0.0165)
+(-0.0060 -0.0525 0.0165)
+(-0.0030 -0.0525 0.0165)
+(0.0000 -0.0525 0.0165)
+(0.0030 -0.0525 0.0165)
+(0.0060 -0.0525 0.0165)
+(-0.0060 -0.0495 0.0165)
+(-0.0030 -0.0495 0.0165)
+(0.0000 -0.0495 0.0165)
+(0.0030 -0.0495 0.0165)
+(0.0060 -0.0495 0.0165)
+(-0.0060 -0.0465 0.0165)
+(-0.0030 -0.0465 0.0165)
+(0.0000 -0.0465 0.0165)
+(0.0030 -0.0465 0.0165)
+(0.0060 -0.0465 0.0165)
+(-0.0060 -0.0435 0.0165)
+(-0.0030 -0.0435 0.0165)
+(0.0000 -0.0435 0.0165)
+(0.0030 -0.0435 0.0165)
+(0.0060 -0.0435 0.0165)
+(-0.0060 -0.0405 0.0165)
+(-0.0030 -0.0405 0.0165)
+(0.0000 -0.0405 0.0165)
+(0.0030 -0.0405 0.0165)
+(0.0060 -0.0405 0.0165)
+(-0.0060 -0.0375 0.0165)
+(-0.0030 -0.0375 0.0165)
+(0.0000 -0.0375 0.0165)
+(0.0030 -0.0375 0.0165)
+(0.0060 -0.0375 0.0165)
+(-0.0060 -0.0345 0.0165)
+(-0.0030 -0.0345 0.0165)
+(0.0000 -0.0345 0.0165)
+(0.0030 -0.0345 0.0165)
+(0.0060 -0.0345 0.0165)
+(-0.0060 -0.0315 0.0165)
+(-0.0030 -0.0315 0.0165)
+(0.0000 -0.0315 0.0165)
+(0.0030 -0.0315 0.0165)
+(0.0060 -0.0315 0.0165)
+(-0.0060 -0.0285 0.0165)
+(-0.0030 -0.0285 0.0165)
+(0.0000 -0.0285 0.0165)
+(0.0030 -0.0285 0.0165)
+(0.0060 -0.0285 0.0165)
+(-0.0060 -0.0255 0.0165)
+(-0.0030 -0.0255 0.0165)
+(0.0000 -0.0255 0.0165)
+(0.0030 -0.0255 0.0165)
+(0.0060 -0.0255 0.0165)
+(-0.0060 -0.0225 0.0165)
+(-0.0030 -0.0225 0.0165)
+(0.0000 -0.0225 0.0165)
+(0.0030 -0.0225 0.0165)
+(0.0060 -0.0225 0.0165)
+(-0.0060 -0.0195 0.0165)
+(-0.0030 -0.0195 0.0165)
+(0.0000 -0.0195 0.0165)
+(0.0030 -0.0195 0.0165)
+(0.0060 -0.0195 0.0165)
+(-0.0060 -0.0165 0.0165)
+(-0.0030 -0.0165 0.0165)
+(0.0000 -0.0165 0.0165)
+(0.0030 -0.0165 0.0165)
+(0.0060 -0.0165 0.0165)
+(-0.0060 -0.0135 0.0165)
+(-0.0030 -0.0135 0.0165)
+(0.0000 -0.0135 0.0165)
+(0.0030 -0.0135 0.0165)
+(0.0060 -0.0135 0.0165)
+(-0.0060 -0.0105 0.0165)
+(-0.0030 -0.0105 0.0165)
+(0.0000 -0.0105 0.0165)
+(0.0030 -0.0105 0.0165)
+(0.0060 -0.0105 0.0165)
+(-0.0060 -0.0075 0.0165)
+(-0.0030 -0.0075 0.0165)
+(0.0000 -0.0075 0.0165)
+(0.0030 -0.0075 0.0165)
+(0.0060 -0.0075 0.0165)
+(-0.0060 -0.0045 0.0165)
+(-0.0030 -0.0045 0.0165)
+(0.0000 -0.0045 0.0165)
+(0.0030 -0.0045 0.0165)
+(0.0060 -0.0045 0.0165)
+(-0.0060 -0.0015 0.0165)
+(-0.0030 -0.0015 0.0165)
+(0.0000 -0.0015 0.0165)
+(0.0030 -0.0015 0.0165)
+(0.0060 -0.0015 0.0165)
+(-0.0060 0.0015 0.0165)
+(-0.0030 0.0015 0.0165)
+(0.0000 0.0015 0.0165)
+(0.0030 0.0015 0.0165)
+(0.0060 0.0015 0.0165)
+(-0.0060 0.0045 0.0165)
+(-0.0030 0.0045 0.0165)
+(0.0000 0.0045 0.0165)
+(0.0030 0.0045 0.0165)
+(0.0060 0.0045 0.0165)
+(-0.0060 0.0075 0.0165)
+(-0.0030 0.0075 0.0165)
+(0.0000 0.0075 0.0165)
+(0.0030 0.0075 0.0165)
+(0.0060 0.0075 0.0165)
+(-0.0060 0.0105 0.0165)
+(-0.0030 0.0105 0.0165)
+(0.0000 0.0105 0.0165)
+(0.0030 0.0105 0.0165)
+(0.0060 0.0105 0.0165)
+(-0.0060 0.0135 0.0165)
+(-0.0030 0.0135 0.0165)
+(0.0000 0.0135 0.0165)
+(0.0030 0.0135 0.0165)
+(0.0060 0.0135 0.0165)
+(-0.0060 0.0165 0.0165)
+(-0.0030 0.0165 0.0165)
+(0.0000 0.0165 0.0165)
+(0.0030 0.0165 0.0165)
+(0.0060 0.0165 0.0165)
+(-0.0060 0.0195 0.0165)
+(-0.0030 0.0195 0.0165)
+(0.0000 0.0195 0.0165)
+(0.0030 0.0195 0.0165)
+(0.0060 0.0195 0.0165)
+(-0.0060 0.0225 0.0165)
+(-0.0030 0.0225 0.0165)
+(0.0000 0.0225 0.0165)
+(0.0030 0.0225 0.0165)
+(0.0060 0.0225 0.0165)
+(-0.0060 0.0255 0.0165)
+(-0.0030 0.0255 0.0165)
+(0.0000 0.0255 0.0165)
+(0.0030 0.0255 0.0165)
+(0.0060 0.0255 0.0165)
+(-0.0060 0.0285 0.0165)
+(-0.0030 0.0285 0.0165)
+(0.0000 0.0285 0.0165)
+(0.0030 0.0285 0.0165)
+(0.0060 0.0285 0.0165)
+(-0.0060 0.0315 0.0165)
+(-0.0030 0.0315 0.0165)
+(0.0000 0.0315 0.0165)
+(0.0030 0.0315 0.0165)
+(0.0060 0.0315 0.0165)
+(-0.0060 0.0345 0.0165)
+(-0.0030 0.0345 0.0165)
+(0.0000 0.0345 0.0165)
+(0.0030 0.0345 0.0165)
+(0.0060 0.0345 0.0165)
+(-0.0060 0.0375 0.0165)
+(-0.0030 0.0375 0.0165)
+(0.0000 0.0375 0.0165)
+(0.0030 0.0375 0.0165)
+(0.0060 0.0375 0.0165)
+(-0.0060 0.0405 0.0165)
+(-0.0030 0.0405 0.0165)
+(0.0000 0.0405 0.0165)
+(0.0030 0.0405 0.0165)
+(0.0060 0.0405 0.0165)
+(-0.0060 0.0435 0.0165)
+(-0.0030 0.0435 0.0165)
+(0.0000 0.0435 0.0165)
+(0.0030 0.0435 0.0165)
+(0.0060 0.0435 0.0165)
+(-0.0060 0.0465 0.0165)
+(-0.0030 0.0465 0.0165)
+(0.0000 0.0465 0.0165)
+(0.0030 0.0465 0.0165)
+(0.0060 0.0465 0.0165)
+(-0.0060 0.0495 0.0165)
+(-0.0030 0.0495 0.0165)
+(0.0000 0.0495 0.0165)
+(0.0030 0.0495 0.0165)
+(0.0060 0.0495 0.0165)
+(-0.0060 0.0525 0.0165)
+(-0.0030 0.0525 0.0165)
+(0.0000 0.0525 0.0165)
+(0.0030 0.0525 0.0165)
+(0.0060 0.0525 0.0165)
+(-0.0060 0.0555 0.0165)
+(-0.0030 0.0555 0.0165)
+(0.0000 0.0555 0.0165)
+(0.0030 0.0555 0.0165)
+(0.0060 0.0555 0.0165)
+(-0.0060 0.0585 0.0165)
+(-0.0030 0.0585 0.0165)
+(0.0000 0.0585 0.0165)
+(0.0030 0.0585 0.0165)
+(0.0060 0.0585 0.0165)
+(-0.0060 0.0615 0.0165)
+(-0.0030 0.0615 0.0165)
+(0.0000 0.0615 0.0165)
+(0.0030 0.0615 0.0165)
+(0.0060 0.0615 0.0165)
+(-0.0060 0.0645 0.0165)
+(-0.0030 0.0645 0.0165)
+(0.0000 0.0645 0.0165)
+(0.0030 0.0645 0.0165)
+(0.0060 0.0645 0.0165)
+(-0.0060 0.0675 0.0165)
+(-0.0030 0.0675 0.0165)
+(0.0000 0.0675 0.0165)
+(0.0030 0.0675 0.0165)
+(0.0060 0.0675 0.0165)
+(-0.0060 0.0705 0.0165)
+(-0.0030 0.0705 0.0165)
+(0.0000 0.0705 0.0165)
+(0.0030 0.0705 0.0165)
+(0.0060 0.0705 0.0165)
+(-0.0060 0.0735 0.0165)
+(-0.0030 0.0735 0.0165)
+(0.0000 0.0735 0.0165)
+(0.0030 0.0735 0.0165)
+(0.0060 0.0735 0.0165)
+(-0.0060 -0.0735 0.0195)
+(-0.0030 -0.0735 0.0195)
+(0.0000 -0.0735 0.0195)
+(0.0030 -0.0735 0.0195)
+(0.0060 -0.0735 0.0195)
+(-0.0060 -0.0705 0.0195)
+(-0.0030 -0.0705 0.0195)
+(0.0000 -0.0705 0.0195)
+(0.0030 -0.0705 0.0195)
+(0.0060 -0.0705 0.0195)
+(-0.0060 -0.0675 0.0195)
+(-0.0030 -0.0675 0.0195)
+(0.0000 -0.0675 0.0195)
+(0.0030 -0.0675 0.0195)
+(0.0060 -0.0675 0.0195)
+(-0.0060 -0.0645 0.0195)
+(-0.0030 -0.0645 0.0195)
+(0.0000 -0.0645 0.0195)
+(0.0030 -0.0645 0.0195)
+(0.0060 -0.0645 0.0195)
+(-0.0060 -0.0615 0.0195)
+(-0.0030 -0.0615 0.0195)
+(0.0000 -0.0615 0.0195)
+(0.0030 -0.0615 0.0195)
+(0.0060 -0.0615 0.0195)
+(-0.0060 -0.0585 0.0195)
+(-0.0030 -0.0585 0.0195)
+(0.0000 -0.0585 0.0195)
+(0.0030 -0.0585 0.0195)
+(0.0060 -0.0585 0.0195)
+(-0.0060 -0.0555 0.0195)
+(-0.0030 -0.0555 0.0195)
+(0.0000 -0.0555 0.0195)
+(0.0030 -0.0555 0.0195)
+(0.0060 -0.0555 0.0195)
+(-0.0060 -0.0525 0.0195)
+(-0.0030 -0.0525 0.0195)
+(0.0000 -0.0525 0.0195)
+(0.0030 -0.0525 0.0195)
+(0.0060 -0.0525 0.0195)
+(-0.0060 -0.0495 0.0195)
+(-0.0030 -0.0495 0.0195)
+(0.0000 -0.0495 0.0195)
+(0.0030 -0.0495 0.0195)
+(0.0060 -0.0495 0.0195)
+(-0.0060 -0.0465 0.0195)
+(-0.0030 -0.0465 0.0195)
+(0.0000 -0.0465 0.0195)
+(0.0030 -0.0465 0.0195)
+(0.0060 -0.0465 0.0195)
+(-0.0060 -0.0435 0.0195)
+(-0.0030 -0.0435 0.0195)
+(0.0000 -0.0435 0.0195)
+(0.0030 -0.0435 0.0195)
+(0.0060 -0.0435 0.0195)
+(-0.0060 -0.0405 0.0195)
+(-0.0030 -0.0405 0.0195)
+(0.0000 -0.0405 0.0195)
+(0.0030 -0.0405 0.0195)
+(0.0060 -0.0405 0.0195)
+(-0.0060 -0.0375 0.0195)
+(-0.0030 -0.0375 0.0195)
+(0.0000 -0.0375 0.0195)
+(0.0030 -0.0375 0.0195)
+(0.0060 -0.0375 0.0195)
+(-0.0060 -0.0345 0.0195)
+(-0.0030 -0.0345 0.0195)
+(0.0000 -0.0345 0.0195)
+(0.0030 -0.0345 0.0195)
+(0.0060 -0.0345 0.0195)
+(-0.0060 -0.0315 0.0195)
+(-0.0030 -0.0315 0.0195)
+(0.0000 -0.0315 0.0195)
+(0.0030 -0.0315 0.0195)
+(0.0060 -0.0315 0.0195)
+(-0.0060 -0.0285 0.0195)
+(-0.0030 -0.0285 0.0195)
+(0.0000 -0.0285 0.0195)
+(0.0030 -0.0285 0.0195)
+(0.0060 -0.0285 0.0195)
+(-0.0060 -0.0255 0.0195)
+(-0.0030 -0.0255 0.0195)
+(0.0000 -0.0255 0.0195)
+(0.0030 -0.0255 0.0195)
+(0.0060 -0.0255 0.0195)
+(-0.0060 -0.0225 0.0195)
+(-0.0030 -0.0225 0.0195)
+(0.0000 -0.0225 0.0195)
+(0.0030 -0.0225 0.0195)
+(0.0060 -0.0225 0.0195)
+(-0.0060 -0.0195 0.0195)
+(-0.0030 -0.0195 0.0195)
+(0.0000 -0.0195 0.0195)
+(0.0030 -0.0195 0.0195)
+(0.0060 -0.0195 0.0195)
+(-0.0060 -0.0165 0.0195)
+(-0.0030 -0.0165 0.0195)
+(0.0000 -0.0165 0.0195)
+(0.0030 -0.0165 0.0195)
+(0.0060 -0.0165 0.0195)
+(-0.0060 -0.0135 0.0195)
+(-0.0030 -0.0135 0.0195)
+(0.0000 -0.0135 0.0195)
+(0.0030 -0.0135 0.0195)
+(0.0060 -0.0135 0.0195)
+(-0.0060 -0.0105 0.0195)
+(-0.0030 -0.0105 0.0195)
+(0.0000 -0.0105 0.0195)
+(0.0030 -0.0105 0.0195)
+(0.0060 -0.0105 0.0195)
+(-0.0060 -0.0075 0.0195)
+(-0.0030 -0.0075 0.0195)
+(0.0000 -0.0075 0.0195)
+(0.0030 -0.0075 0.0195)
+(0.0060 -0.0075 0.0195)
+(-0.0060 -0.0045 0.0195)
+(-0.0030 -0.0045 0.0195)
+(0.0000 -0.0045 0.0195)
+(0.0030 -0.0045 0.0195)
+(0.0060 -0.0045 0.0195)
+(-0.0060 -0.0015 0.0195)
+(-0.0030 -0.0015 0.0195)
+(0.0000 -0.0015 0.0195)
+(0.0030 -0.0015 0.0195)
+(0.0060 -0.0015 0.0195)
+(-0.0060 0.0015 0.0195)
+(-0.0030 0.0015 0.0195)
+(0.0000 0.0015 0.0195)
+(0.0030 0.0015 0.0195)
+(0.0060 0.0015 0.0195)
+(-0.0060 0.0045 0.0195)
+(-0.0030 0.0045 0.0195)
+(0.0000 0.0045 0.0195)
+(0.0030 0.0045 0.0195)
+(0.0060 0.0045 0.0195)
+(-0.0060 0.0075 0.0195)
+(-0.0030 0.0075 0.0195)
+(0.0000 0.0075 0.0195)
+(0.0030 0.0075 0.0195)
+(0.0060 0.0075 0.0195)
+(-0.0060 0.0105 0.0195)
+(-0.0030 0.0105 0.0195)
+(0.0000 0.0105 0.0195)
+(0.0030 0.0105 0.0195)
+(0.0060 0.0105 0.0195)
+(-0.0060 0.0135 0.0195)
+(-0.0030 0.0135 0.0195)
+(0.0000 0.0135 0.0195)
+(0.0030 0.0135 0.0195)
+(0.0060 0.0135 0.0195)
+(-0.0060 0.0165 0.0195)
+(-0.0030 0.0165 0.0195)
+(0.0000 0.0165 0.0195)
+(0.0030 0.0165 0.0195)
+(0.0060 0.0165 0.0195)
+(-0.0060 0.0195 0.0195)
+(-0.0030 0.0195 0.0195)
+(0.0000 0.0195 0.0195)
+(0.0030 0.0195 0.0195)
+(0.0060 0.0195 0.0195)
+(-0.0060 0.0225 0.0195)
+(-0.0030 0.0225 0.0195)
+(0.0000 0.0225 0.0195)
+(0.0030 0.0225 0.0195)
+(0.0060 0.0225 0.0195)
+(-0.0060 0.0255 0.0195)
+(-0.0030 0.0255 0.0195)
+(0.0000 0.0255 0.0195)
+(0.0030 0.0255 0.0195)
+(0.0060 0.0255 0.0195)
+(-0.0060 0.0285 0.0195)
+(-0.0030 0.0285 0.0195)
+(0.0000 0.0285 0.0195)
+(0.0030 0.0285 0.0195)
+(0.0060 0.0285 0.0195)
+(-0.0060 0.0315 0.0195)
+(-0.0030 0.0315 0.0195)
+(0.0000 0.0315 0.0195)
+(0.0030 0.0315 0.0195)
+(0.0060 0.0315 0.0195)
+(-0.0060 0.0345 0.0195)
+(-0.0030 0.0345 0.0195)
+(0.0000 0.0345 0.0195)
+(0.0030 0.0345 0.0195)
+(0.0060 0.0345 0.0195)
+(-0.0060 0.0375 0.0195)
+(-0.0030 0.0375 0.0195)
+(0.0000 0.0375 0.0195)
+(0.0030 0.0375 0.0195)
+(0.0060 0.0375 0.0195)
+(-0.0060 0.0405 0.0195)
+(-0.0030 0.0405 0.0195)
+(0.0000 0.0405 0.0195)
+(0.0030 0.0405 0.0195)
+(0.0060 0.0405 0.0195)
+(-0.0060 0.0435 0.0195)
+(-0.0030 0.0435 0.0195)
+(0.0000 0.0435 0.0195)
+(0.0030 0.0435 0.0195)
+(0.0060 0.0435 0.0195)
+(-0.0060 0.0465 0.0195)
+(-0.0030 0.0465 0.0195)
+(0.0000 0.0465 0.0195)
+(0.0030 0.0465 0.0195)
+(0.0060 0.0465 0.0195)
+(-0.0060 0.0495 0.0195)
+(-0.0030 0.0495 0.0195)
+(0.0000 0.0495 0.0195)
+(0.0030 0.0495 0.0195)
+(0.0060 0.0495 0.0195)
+(-0.0060 0.0525 0.0195)
+(-0.0030 0.0525 0.0195)
+(0.0000 0.0525 0.0195)
+(0.0030 0.0525 0.0195)
+(0.0060 0.0525 0.0195)
+(-0.0060 0.0555 0.0195)
+(-0.0030 0.0555 0.0195)
+(0.0000 0.0555 0.0195)
+(0.0030 0.0555 0.0195)
+(0.0060 0.0555 0.0195)
+(-0.0060 0.0585 0.0195)
+(-0.0030 0.0585 0.0195)
+(0.0000 0.0585 0.0195)
+(0.0030 0.0585 0.0195)
+(0.0060 0.0585 0.0195)
+(-0.0060 0.0615 0.0195)
+(-0.0030 0.0615 0.0195)
+(0.0000 0.0615 0.0195)
+(0.0030 0.0615 0.0195)
+(0.0060 0.0615 0.0195)
+(-0.0060 0.0645 0.0195)
+(-0.0030 0.0645 0.0195)
+(0.0000 0.0645 0.0195)
+(0.0030 0.0645 0.0195)
+(0.0060 0.0645 0.0195)
+(-0.0060 0.0675 0.0195)
+(-0.0030 0.0675 0.0195)
+(0.0000 0.0675 0.0195)
+(0.0030 0.0675 0.0195)
+(0.0060 0.0675 0.0195)
+(-0.0060 0.0705 0.0195)
+(-0.0030 0.0705 0.0195)
+(0.0000 0.0705 0.0195)
+(0.0030 0.0705 0.0195)
+(0.0060 0.0705 0.0195)
+(-0.0060 0.0735 0.0195)
+(-0.0030 0.0735 0.0195)
+(0.0000 0.0735 0.0195)
+(0.0030 0.0735 0.0195)
+(0.0060 0.0735 0.0195)
+(-0.0060 -0.0735 0.0225)
+(-0.0030 -0.0735 0.0225)
+(0.0000 -0.0735 0.0225)
+(0.0030 -0.0735 0.0225)
+(0.0060 -0.0735 0.0225)
+(-0.0060 -0.0705 0.0225)
+(-0.0030 -0.0705 0.0225)
+(0.0000 -0.0705 0.0225)
+(0.0030 -0.0705 0.0225)
+(0.0060 -0.0705 0.0225)
+(-0.0060 -0.0675 0.0225)
+(-0.0030 -0.0675 0.0225)
+(0.0000 -0.0675 0.0225)
+(0.0030 -0.0675 0.0225)
+(0.0060 -0.0675 0.0225)
+(-0.0060 -0.0645 0.0225)
+(-0.0030 -0.0645 0.0225)
+(0.0000 -0.0645 0.0225)
+(0.0030 -0.0645 0.0225)
+(0.0060 -0.0645 0.0225)
+(-0.0060 -0.0615 0.0225)
+(-0.0030 -0.0615 0.0225)
+(0.0000 -0.0615 0.0225)
+(0.0030 -0.0615 0.0225)
+(0.0060 -0.0615 0.0225)
+(-0.0060 -0.0585 0.0225)
+(-0.0030 -0.0585 0.0225)
+(0.0000 -0.0585 0.0225)
+(0.0030 -0.0585 0.0225)
+(0.0060 -0.0585 0.0225)
+(-0.0060 -0.0555 0.0225)
+(-0.0030 -0.0555 0.0225)
+(0.0000 -0.0555 0.0225)
+(0.0030 -0.0555 0.0225)
+(0.0060 -0.0555 0.0225)
+(-0.0060 -0.0525 0.0225)
+(-0.0030 -0.0525 0.0225)
+(0.0000 -0.0525 0.0225)
+(0.0030 -0.0525 0.0225)
+(0.0060 -0.0525 0.0225)
+(-0.0060 -0.0495 0.0225)
+(-0.0030 -0.0495 0.0225)
+(0.0000 -0.0495 0.0225)
+(0.0030 -0.0495 0.0225)
+(0.0060 -0.0495 0.0225)
+(-0.0060 -0.0465 0.0225)
+(-0.0030 -0.0465 0.0225)
+(0.0000 -0.0465 0.0225)
+(0.0030 -0.0465 0.0225)
+(0.0060 -0.0465 0.0225)
+(-0.0060 -0.0435 0.0225)
+(-0.0030 -0.0435 0.0225)
+(0.0000 -0.0435 0.0225)
+(0.0030 -0.0435 0.0225)
+(0.0060 -0.0435 0.0225)
+(-0.0060 -0.0405 0.0225)
+(-0.0030 -0.0405 0.0225)
+(0.0000 -0.0405 0.0225)
+(0.0030 -0.0405 0.0225)
+(0.0060 -0.0405 0.0225)
+(-0.0060 -0.0375 0.0225)
+(-0.0030 -0.0375 0.0225)
+(0.0000 -0.0375 0.0225)
+(0.0030 -0.0375 0.0225)
+(0.0060 -0.0375 0.0225)
+(-0.0060 -0.0345 0.0225)
+(-0.0030 -0.0345 0.0225)
+(0.0000 -0.0345 0.0225)
+(0.0030 -0.0345 0.0225)
+(0.0060 -0.0345 0.0225)
+(-0.0060 -0.0315 0.0225)
+(-0.0030 -0.0315 0.0225)
+(0.0000 -0.0315 0.0225)
+(0.0030 -0.0315 0.0225)
+(0.0060 -0.0315 0.0225)
+(-0.0060 -0.0285 0.0225)
+(-0.0030 -0.0285 0.0225)
+(0.0000 -0.0285 0.0225)
+(0.0030 -0.0285 0.0225)
+(0.0060 -0.0285 0.0225)
+(-0.0060 -0.0255 0.0225)
+(-0.0030 -0.0255 0.0225)
+(0.0000 -0.0255 0.0225)
+(0.0030 -0.0255 0.0225)
+(0.0060 -0.0255 0.0225)
+(-0.0060 -0.0225 0.0225)
+(-0.0030 -0.0225 0.0225)
+(0.0000 -0.0225 0.0225)
+(0.0030 -0.0225 0.0225)
+(0.0060 -0.0225 0.0225)
+(-0.0060 -0.0195 0.0225)
+(-0.0030 -0.0195 0.0225)
+(0.0000 -0.0195 0.0225)
+(0.0030 -0.0195 0.0225)
+(0.0060 -0.0195 0.0225)
+(-0.0060 -0.0165 0.0225)
+(-0.0030 -0.0165 0.0225)
+(0.0000 -0.0165 0.0225)
+(0.0030 -0.0165 0.0225)
+(0.0060 -0.0165 0.0225)
+(-0.0060 -0.0135 0.0225)
+(-0.0030 -0.0135 0.0225)
+(0.0000 -0.0135 0.0225)
+(0.0030 -0.0135 0.0225)
+(0.0060 -0.0135 0.0225)
+(-0.0060 -0.0105 0.0225)
+(-0.0030 -0.0105 0.0225)
+(0.0000 -0.0105 0.0225)
+(0.0030 -0.0105 0.0225)
+(0.0060 -0.0105 0.0225)
+(-0.0060 -0.0075 0.0225)
+(-0.0030 -0.0075 0.0225)
+(0.0000 -0.0075 0.0225)
+(0.0030 -0.0075 0.0225)
+(0.0060 -0.0075 0.0225)
+(-0.0060 -0.0045 0.0225)
+(-0.0030 -0.0045 0.0225)
+(0.0000 -0.0045 0.0225)
+(0.0030 -0.0045 0.0225)
+(0.0060 -0.0045 0.0225)
+(-0.0060 -0.0015 0.0225)
+(-0.0030 -0.0015 0.0225)
+(0.0000 -0.0015 0.0225)
+(0.0030 -0.0015 0.0225)
+(0.0060 -0.0015 0.0225)
+(-0.0060 0.0015 0.0225)
+(-0.0030 0.0015 0.0225)
+(0.0000 0.0015 0.0225)
+(0.0030 0.0015 0.0225)
+(0.0060 0.0015 0.0225)
+(-0.0060 0.0045 0.0225)
+(-0.0030 0.0045 0.0225)
+(0.0000 0.0045 0.0225)
+(0.0030 0.0045 0.0225)
+(0.0060 0.0045 0.0225)
+(-0.0060 0.0075 0.0225)
+(-0.0030 0.0075 0.0225)
+(0.0000 0.0075 0.0225)
+(0.0030 0.0075 0.0225)
+(0.0060 0.0075 0.0225)
+(-0.0060 0.0105 0.0225)
+(-0.0030 0.0105 0.0225)
+(0.0000 0.0105 0.0225)
+(0.0030 0.0105 0.0225)
+(0.0060 0.0105 0.0225)
+(-0.0060 0.0135 0.0225)
+(-0.0030 0.0135 0.0225)
+(0.0000 0.0135 0.0225)
+(0.0030 0.0135 0.0225)
+(0.0060 0.0135 0.0225)
+(-0.0060 0.0165 0.0225)
+(-0.0030 0.0165 0.0225)
+(0.0000 0.0165 0.0225)
+(0.0030 0.0165 0.0225)
+(0.0060 0.0165 0.0225)
+(-0.0060 0.0195 0.0225)
+(-0.0030 0.0195 0.0225)
+(0.0000 0.0195 0.0225)
+(0.0030 0.0195 0.0225)
+(0.0060 0.0195 0.0225)
+(-0.0060 0.0225 0.0225)
+(-0.0030 0.0225 0.0225)
+(0.0000 0.0225 0.0225)
+(0.0030 0.0225 0.0225)
+(0.0060 0.0225 0.0225)
+(-0.0060 0.0255 0.0225)
+(-0.0030 0.0255 0.0225)
+(0.0000 0.0255 0.0225)
+(0.0030 0.0255 0.0225)
+(0.0060 0.0255 0.0225)
+(-0.0060 0.0285 0.0225)
+(-0.0030 0.0285 0.0225)
+(0.0000 0.0285 0.0225)
+(0.0030 0.0285 0.0225)
+(0.0060 0.0285 0.0225)
+(-0.0060 0.0315 0.0225)
+(-0.0030 0.0315 0.0225)
+(0.0000 0.0315 0.0225)
+(0.0030 0.0315 0.0225)
+(0.0060 0.0315 0.0225)
+(-0.0060 0.0345 0.0225)
+(-0.0030 0.0345 0.0225)
+(0.0000 0.0345 0.0225)
+(0.0030 0.0345 0.0225)
+(0.0060 0.0345 0.0225)
+(-0.0060 0.0375 0.0225)
+(-0.0030 0.0375 0.0225)
+(0.0000 0.0375 0.0225)
+(0.0030 0.0375 0.0225)
+(0.0060 0.0375 0.0225)
+(-0.0060 0.0405 0.0225)
+(-0.0030 0.0405 0.0225)
+(0.0000 0.0405 0.0225)
+(0.0030 0.0405 0.0225)
+(0.0060 0.0405 0.0225)
+(-0.0060 0.0435 0.0225)
+(-0.0030 0.0435 0.0225)
+(0.0000 0.0435 0.0225)
+(0.0030 0.0435 0.0225)
+(0.0060 0.0435 0.0225)
+(-0.0060 0.0465 0.0225)
+(-0.0030 0.0465 0.0225)
+(0.0000 0.0465 0.0225)
+(0.0030 0.0465 0.0225)
+(0.0060 0.0465 0.0225)
+(-0.0060 0.0495 0.0225)
+(-0.0030 0.0495 0.0225)
+(0.0000 0.0495 0.0225)
+(0.0030 0.0495 0.0225)
+(0.0060 0.0495 0.0225)
+(-0.0060 0.0525 0.0225)
+(-0.0030 0.0525 0.0225)
+(0.0000 0.0525 0.0225)
+(0.0030 0.0525 0.0225)
+(0.0060 0.0525 0.0225)
+(-0.0060 0.0555 0.0225)
+(-0.0030 0.0555 0.0225)
+(0.0000 0.0555 0.0225)
+(0.0030 0.0555 0.0225)
+(0.0060 0.0555 0.0225)
+(-0.0060 0.0585 0.0225)
+(-0.0030 0.0585 0.0225)
+(0.0000 0.0585 0.0225)
+(0.0030 0.0585 0.0225)
+(0.0060 0.0585 0.0225)
+(-0.0060 0.0615 0.0225)
+(-0.0030 0.0615 0.0225)
+(0.0000 0.0615 0.0225)
+(0.0030 0.0615 0.0225)
+(0.0060 0.0615 0.0225)
+(-0.0060 0.0645 0.0225)
+(-0.0030 0.0645 0.0225)
+(0.0000 0.0645 0.0225)
+(0.0030 0.0645 0.0225)
+(0.0060 0.0645 0.0225)
+(-0.0060 0.0675 0.0225)
+(-0.0030 0.0675 0.0225)
+(0.0000 0.0675 0.0225)
+(0.0030 0.0675 0.0225)
+(0.0060 0.0675 0.0225)
+(-0.0060 0.0705 0.0225)
+(-0.0030 0.0705 0.0225)
+(0.0000 0.0705 0.0225)
+(0.0030 0.0705 0.0225)
+(0.0060 0.0705 0.0225)
+(-0.0060 0.0735 0.0225)
+(-0.0030 0.0735 0.0225)
+(0.0000 0.0735 0.0225)
+(0.0030 0.0735 0.0225)
+(0.0060 0.0735 0.0225)
+(-0.0060 -0.0735 0.0255)
+(-0.0030 -0.0735 0.0255)
+(0.0000 -0.0735 0.0255)
+(0.0030 -0.0735 0.0255)
+(0.0060 -0.0735 0.0255)
+(-0.0060 -0.0705 0.0255)
+(-0.0030 -0.0705 0.0255)
+(0.0000 -0.0705 0.0255)
+(0.0030 -0.0705 0.0255)
+(0.0060 -0.0705 0.0255)
+(-0.0060 -0.0675 0.0255)
+(-0.0030 -0.0675 0.0255)
+(0.0000 -0.0675 0.0255)
+(0.0030 -0.0675 0.0255)
+(0.0060 -0.0675 0.0255)
+(-0.0060 -0.0645 0.0255)
+(-0.0030 -0.0645 0.0255)
+(0.0000 -0.0645 0.0255)
+(0.0030 -0.0645 0.0255)
+(0.0060 -0.0645 0.0255)
+(-0.0060 -0.0615 0.0255)
+(-0.0030 -0.0615 0.0255)
+(0.0000 -0.0615 0.0255)
+(0.0030 -0.0615 0.0255)
+(0.0060 -0.0615 0.0255)
+(-0.0060 -0.0585 0.0255)
+(-0.0030 -0.0585 0.0255)
+(0.0000 -0.0585 0.0255)
+(0.0030 -0.0585 0.0255)
+(0.0060 -0.0585 0.0255)
+(-0.0060 -0.0555 0.0255)
+(-0.0030 -0.0555 0.0255)
+(0.0000 -0.0555 0.0255)
+(0.0030 -0.0555 0.0255)
+(0.0060 -0.0555 0.0255)
+(-0.0060 -0.0525 0.0255)
+(-0.0030 -0.0525 0.0255)
+(0.0000 -0.0525 0.0255)
+(0.0030 -0.0525 0.0255)
+(0.0060 -0.0525 0.0255)
+(-0.0060 -0.0495 0.0255)
+(-0.0030 -0.0495 0.0255)
+(0.0000 -0.0495 0.0255)
+(0.0030 -0.0495 0.0255)
+(0.0060 -0.0495 0.0255)
+(-0.0060 -0.0465 0.0255)
+(-0.0030 -0.0465 0.0255)
+(0.0000 -0.0465 0.0255)
+(0.0030 -0.0465 0.0255)
+(0.0060 -0.0465 0.0255)
+(-0.0060 -0.0435 0.0255)
+(-0.0030 -0.0435 0.0255)
+(0.0000 -0.0435 0.0255)
+(0.0030 -0.0435 0.0255)
+(0.0060 -0.0435 0.0255)
+(-0.0060 -0.0405 0.0255)
+(-0.0030 -0.0405 0.0255)
+(0.0000 -0.0405 0.0255)
+(0.0030 -0.0405 0.0255)
+(0.0060 -0.0405 0.0255)
+(-0.0060 -0.0375 0.0255)
+(-0.0030 -0.0375 0.0255)
+(0.0000 -0.0375 0.0255)
+(0.0030 -0.0375 0.0255)
+(0.0060 -0.0375 0.0255)
+(-0.0060 -0.0345 0.0255)
+(-0.0030 -0.0345 0.0255)
+(0.0000 -0.0345 0.0255)
+(0.0030 -0.0345 0.0255)
+(0.0060 -0.0345 0.0255)
+(-0.0060 -0.0315 0.0255)
+(-0.0030 -0.0315 0.0255)
+(0.0000 -0.0315 0.0255)
+(0.0030 -0.0315 0.0255)
+(0.0060 -0.0315 0.0255)
+(-0.0060 -0.0285 0.0255)
+(-0.0030 -0.0285 0.0255)
+(0.0000 -0.0285 0.0255)
+(0.0030 -0.0285 0.0255)
+(0.0060 -0.0285 0.0255)
+(-0.0060 -0.0255 0.0255)
+(-0.0030 -0.0255 0.0255)
+(0.0000 -0.0255 0.0255)
+(0.0030 -0.0255 0.0255)
+(0.0060 -0.0255 0.0255)
+(-0.0060 -0.0225 0.0255)
+(-0.0030 -0.0225 0.0255)
+(0.0000 -0.0225 0.0255)
+(0.0030 -0.0225 0.0255)
+(0.0060 -0.0225 0.0255)
+(-0.0060 -0.0195 0.0255)
+(-0.0030 -0.0195 0.0255)
+(0.0000 -0.0195 0.0255)
+(0.0030 -0.0195 0.0255)
+(0.0060 -0.0195 0.0255)
+(-0.0060 -0.0165 0.0255)
+(-0.0030 -0.0165 0.0255)
+(0.0000 -0.0165 0.0255)
+(0.0030 -0.0165 0.0255)
+(0.0060 -0.0165 0.0255)
+(-0.0060 -0.0135 0.0255)
+(-0.0030 -0.0135 0.0255)
+(0.0000 -0.0135 0.0255)
+(0.0030 -0.0135 0.0255)
+(0.0060 -0.0135 0.0255)
+(-0.0060 -0.0105 0.0255)
+(-0.0030 -0.0105 0.0255)
+(0.0000 -0.0105 0.0255)
+(0.0030 -0.0105 0.0255)
+(0.0060 -0.0105 0.0255)
+(-0.0060 -0.0075 0.0255)
+(-0.0030 -0.0075 0.0255)
+(0.0000 -0.0075 0.0255)
+(0.0030 -0.0075 0.0255)
+(0.0060 -0.0075 0.0255)
+(-0.0060 -0.0045 0.0255)
+(-0.0030 -0.0045 0.0255)
+(0.0000 -0.0045 0.0255)
+(0.0030 -0.0045 0.0255)
+(0.0060 -0.0045 0.0255)
+(-0.0060 -0.0015 0.0255)
+(-0.0030 -0.0015 0.0255)
+(0.0000 -0.0015 0.0255)
+(0.0030 -0.0015 0.0255)
+(0.0060 -0.0015 0.0255)
+(-0.0060 0.0015 0.0255)
+(-0.0030 0.0015 0.0255)
+(0.0000 0.0015 0.0255)
+(0.0030 0.0015 0.0255)
+(0.0060 0.0015 0.0255)
+(-0.0060 0.0045 0.0255)
+(-0.0030 0.0045 0.0255)
+(0.0000 0.0045 0.0255)
+(0.0030 0.0045 0.0255)
+(0.0060 0.0045 0.0255)
+(-0.0060 0.0075 0.0255)
+(-0.0030 0.0075 0.0255)
+(0.0000 0.0075 0.0255)
+(0.0030 0.0075 0.0255)
+(0.0060 0.0075 0.0255)
+(-0.0060 0.0105 0.0255)
+(-0.0030 0.0105 0.0255)
+(0.0000 0.0105 0.0255)
+(0.0030 0.0105 0.0255)
+(0.0060 0.0105 0.0255)
+(-0.0060 0.0135 0.0255)
+(-0.0030 0.0135 0.0255)
+(0.0000 0.0135 0.0255)
+(0.0030 0.0135 0.0255)
+(0.0060 0.0135 0.0255)
+(-0.0060 0.0165 0.0255)
+(-0.0030 0.0165 0.0255)
+(0.0000 0.0165 0.0255)
+(0.0030 0.0165 0.0255)
+(0.0060 0.0165 0.0255)
+(-0.0060 0.0195 0.0255)
+(-0.0030 0.0195 0.0255)
+(0.0000 0.0195 0.0255)
+(0.0030 0.0195 0.0255)
+(0.0060 0.0195 0.0255)
+(-0.0060 0.0225 0.0255)
+(-0.0030 0.0225 0.0255)
+(0.0000 0.0225 0.0255)
+(0.0030 0.0225 0.0255)
+(0.0060 0.0225 0.0255)
+(-0.0060 0.0255 0.0255)
+(-0.0030 0.0255 0.0255)
+(0.0000 0.0255 0.0255)
+(0.0030 0.0255 0.0255)
+(0.0060 0.0255 0.0255)
+(-0.0060 0.0285 0.0255)
+(-0.0030 0.0285 0.0255)
+(0.0000 0.0285 0.0255)
+(0.0030 0.0285 0.0255)
+(0.0060 0.0285 0.0255)
+(-0.0060 0.0315 0.0255)
+(-0.0030 0.0315 0.0255)
+(0.0000 0.0315 0.0255)
+(0.0030 0.0315 0.0255)
+(0.0060 0.0315 0.0255)
+(-0.0060 0.0345 0.0255)
+(-0.0030 0.0345 0.0255)
+(0.0000 0.0345 0.0255)
+(0.0030 0.0345 0.0255)
+(0.0060 0.0345 0.0255)
+(-0.0060 0.0375 0.0255)
+(-0.0030 0.0375 0.0255)
+(0.0000 0.0375 0.0255)
+(0.0030 0.0375 0.0255)
+(0.0060 0.0375 0.0255)
+(-0.0060 0.0405 0.0255)
+(-0.0030 0.0405 0.0255)
+(0.0000 0.0405 0.0255)
+(0.0030 0.0405 0.0255)
+(0.0060 0.0405 0.0255)
+(-0.0060 0.0435 0.0255)
+(-0.0030 0.0435 0.0255)
+(0.0000 0.0435 0.0255)
+(0.0030 0.0435 0.0255)
+(0.0060 0.0435 0.0255)
+(-0.0060 0.0465 0.0255)
+(-0.0030 0.0465 0.0255)
+(0.0000 0.0465 0.0255)
+(0.0030 0.0465 0.0255)
+(0.0060 0.0465 0.0255)
+(-0.0060 0.0495 0.0255)
+(-0.0030 0.0495 0.0255)
+(0.0000 0.0495 0.0255)
+(0.0030 0.0495 0.0255)
+(0.0060 0.0495 0.0255)
+(-0.0060 0.0525 0.0255)
+(-0.0030 0.0525 0.0255)
+(0.0000 0.0525 0.0255)
+(0.0030 0.0525 0.0255)
+(0.0060 0.0525 0.0255)
+(-0.0060 0.0555 0.0255)
+(-0.0030 0.0555 0.0255)
+(0.0000 0.0555 0.0255)
+(0.0030 0.0555 0.0255)
+(0.0060 0.0555 0.0255)
+(-0.0060 0.0585 0.0255)
+(-0.0030 0.0585 0.0255)
+(0.0000 0.0585 0.0255)
+(0.0030 0.0585 0.0255)
+(0.0060 0.0585 0.0255)
+(-0.0060 0.0615 0.0255)
+(-0.0030 0.0615 0.0255)
+(0.0000 0.0615 0.0255)
+(0.0030 0.0615 0.0255)
+(0.0060 0.0615 0.0255)
+(-0.0060 0.0645 0.0255)
+(-0.0030 0.0645 0.0255)
+(0.0000 0.0645 0.0255)
+(0.0030 0.0645 0.0255)
+(0.0060 0.0645 0.0255)
+(-0.0060 0.0675 0.0255)
+(-0.0030 0.0675 0.0255)
+(0.0000 0.0675 0.0255)
+(0.0030 0.0675 0.0255)
+(0.0060 0.0675 0.0255)
+(-0.0060 0.0705 0.0255)
+(-0.0030 0.0705 0.0255)
+(0.0000 0.0705 0.0255)
+(0.0030 0.0705 0.0255)
+(0.0060 0.0705 0.0255)
+(-0.0060 0.0735 0.0255)
+(-0.0030 0.0735 0.0255)
+(0.0000 0.0735 0.0255)
+(0.0030 0.0735 0.0255)
+(0.0060 0.0735 0.0255)
+(-0.0060 -0.0735 0.0285)
+(-0.0030 -0.0735 0.0285)
+(0.0000 -0.0735 0.0285)
+(0.0030 -0.0735 0.0285)
+(0.0060 -0.0735 0.0285)
+(-0.0060 -0.0705 0.0285)
+(-0.0030 -0.0705 0.0285)
+(0.0000 -0.0705 0.0285)
+(0.0030 -0.0705 0.0285)
+(0.0060 -0.0705 0.0285)
+(-0.0060 -0.0675 0.0285)
+(-0.0030 -0.0675 0.0285)
+(0.0000 -0.0675 0.0285)
+(0.0030 -0.0675 0.0285)
+(0.0060 -0.0675 0.0285)
+(-0.0060 -0.0645 0.0285)
+(-0.0030 -0.0645 0.0285)
+(0.0000 -0.0645 0.0285)
+(0.0030 -0.0645 0.0285)
+(0.0060 -0.0645 0.0285)
+(-0.0060 -0.0615 0.0285)
+(-0.0030 -0.0615 0.0285)
+(0.0000 -0.0615 0.0285)
+(0.0030 -0.0615 0.0285)
+(0.0060 -0.0615 0.0285)
+(-0.0060 -0.0585 0.0285)
+(-0.0030 -0.0585 0.0285)
+(0.0000 -0.0585 0.0285)
+(0.0030 -0.0585 0.0285)
+(0.0060 -0.0585 0.0285)
+(-0.0060 -0.0555 0.0285)
+(-0.0030 -0.0555 0.0285)
+(0.0000 -0.0555 0.0285)
+(0.0030 -0.0555 0.0285)
+(0.0060 -0.0555 0.0285)
+(-0.0060 -0.0525 0.0285)
+(-0.0030 -0.0525 0.0285)
+(0.0000 -0.0525 0.0285)
+(0.0030 -0.0525 0.0285)
+(0.0060 -0.0525 0.0285)
+(-0.0060 -0.0495 0.0285)
+(-0.0030 -0.0495 0.0285)
+(0.0000 -0.0495 0.0285)
+(0.0030 -0.0495 0.0285)
+(0.0060 -0.0495 0.0285)
+(-0.0060 -0.0465 0.0285)
+(-0.0030 -0.0465 0.0285)
+(0.0000 -0.0465 0.0285)
+(0.0030 -0.0465 0.0285)
+(0.0060 -0.0465 0.0285)
+(-0.0060 -0.0435 0.0285)
+(-0.0030 -0.0435 0.0285)
+(0.0000 -0.0435 0.0285)
+(0.0030 -0.0435 0.0285)
+(0.0060 -0.0435 0.0285)
+(-0.0060 -0.0405 0.0285)
+(-0.0030 -0.0405 0.0285)
+(0.0000 -0.0405 0.0285)
+(0.0030 -0.0405 0.0285)
+(0.0060 -0.0405 0.0285)
+(-0.0060 -0.0375 0.0285)
+(-0.0030 -0.0375 0.0285)
+(0.0000 -0.0375 0.0285)
+(0.0030 -0.0375 0.0285)
+(0.0060 -0.0375 0.0285)
+(-0.0060 -0.0345 0.0285)
+(-0.0030 -0.0345 0.0285)
+(0.0000 -0.0345 0.0285)
+(0.0030 -0.0345 0.0285)
+(0.0060 -0.0345 0.0285)
+(-0.0060 -0.0315 0.0285)
+(-0.0030 -0.0315 0.0285)
+(0.0000 -0.0315 0.0285)
+(0.0030 -0.0315 0.0285)
+(0.0060 -0.0315 0.0285)
+(-0.0060 -0.0285 0.0285)
+(-0.0030 -0.0285 0.0285)
+(0.0000 -0.0285 0.0285)
+(0.0030 -0.0285 0.0285)
+(0.0060 -0.0285 0.0285)
+(-0.0060 -0.0255 0.0285)
+(-0.0030 -0.0255 0.0285)
+(0.0000 -0.0255 0.0285)
+(0.0030 -0.0255 0.0285)
+(0.0060 -0.0255 0.0285)
+(-0.0060 -0.0225 0.0285)
+(-0.0030 -0.0225 0.0285)
+(0.0000 -0.0225 0.0285)
+(0.0030 -0.0225 0.0285)
+(0.0060 -0.0225 0.0285)
+(-0.0060 -0.0195 0.0285)
+(-0.0030 -0.0195 0.0285)
+(0.0000 -0.0195 0.0285)
+(0.0030 -0.0195 0.0285)
+(0.0060 -0.0195 0.0285)
+(-0.0060 -0.0165 0.0285)
+(-0.0030 -0.0165 0.0285)
+(0.0000 -0.0165 0.0285)
+(0.0030 -0.0165 0.0285)
+(0.0060 -0.0165 0.0285)
+(-0.0060 -0.0135 0.0285)
+(-0.0030 -0.0135 0.0285)
+(0.0000 -0.0135 0.0285)
+(0.0030 -0.0135 0.0285)
+(0.0060 -0.0135 0.0285)
+(-0.0060 -0.0105 0.0285)
+(-0.0030 -0.0105 0.0285)
+(0.0000 -0.0105 0.0285)
+(0.0030 -0.0105 0.0285)
+(0.0060 -0.0105 0.0285)
+(-0.0060 -0.0075 0.0285)
+(-0.0030 -0.0075 0.0285)
+(0.0000 -0.0075 0.0285)
+(0.0030 -0.0075 0.0285)
+(0.0060 -0.0075 0.0285)
+(-0.0060 -0.0045 0.0285)
+(-0.0030 -0.0045 0.0285)
+(0.0000 -0.0045 0.0285)
+(0.0030 -0.0045 0.0285)
+(0.0060 -0.0045 0.0285)
+(-0.0060 -0.0015 0.0285)
+(-0.0030 -0.0015 0.0285)
+(0.0000 -0.0015 0.0285)
+(0.0030 -0.0015 0.0285)
+(0.0060 -0.0015 0.0285)
+(-0.0060 0.0015 0.0285)
+(-0.0030 0.0015 0.0285)
+(0.0000 0.0015 0.0285)
+(0.0030 0.0015 0.0285)
+(0.0060 0.0015 0.0285)
+(-0.0060 0.0045 0.0285)
+(-0.0030 0.0045 0.0285)
+(0.0000 0.0045 0.0285)
+(0.0030 0.0045 0.0285)
+(0.0060 0.0045 0.0285)
+(-0.0060 0.0075 0.0285)
+(-0.0030 0.0075 0.0285)
+(0.0000 0.0075 0.0285)
+(0.0030 0.0075 0.0285)
+(0.0060 0.0075 0.0285)
+(-0.0060 0.0105 0.0285)
+(-0.0030 0.0105 0.0285)
+(0.0000 0.0105 0.0285)
+(0.0030 0.0105 0.0285)
+(0.0060 0.0105 0.0285)
+(-0.0060 0.0135 0.0285)
+(-0.0030 0.0135 0.0285)
+(0.0000 0.0135 0.0285)
+(0.0030 0.0135 0.0285)
+(0.0060 0.0135 0.0285)
+(-0.0060 0.0165 0.0285)
+(-0.0030 0.0165 0.0285)
+(0.0000 0.0165 0.0285)
+(0.0030 0.0165 0.0285)
+(0.0060 0.0165 0.0285)
+(-0.0060 0.0195 0.0285)
+(-0.0030 0.0195 0.0285)
+(0.0000 0.0195 0.0285)
+(0.0030 0.0195 0.0285)
+(0.0060 0.0195 0.0285)
+(-0.0060 0.0225 0.0285)
+(-0.0030 0.0225 0.0285)
+(0.0000 0.0225 0.0285)
+(0.0030 0.0225 0.0285)
+(0.0060 0.0225 0.0285)
+(-0.0060 0.0255 0.0285)
+(-0.0030 0.0255 0.0285)
+(0.0000 0.0255 0.0285)
+(0.0030 0.0255 0.0285)
+(0.0060 0.0255 0.0285)
+(-0.0060 0.0285 0.0285)
+(-0.0030 0.0285 0.0285)
+(0.0000 0.0285 0.0285)
+(0.0030 0.0285 0.0285)
+(0.0060 0.0285 0.0285)
+(-0.0060 0.0315 0.0285)
+(-0.0030 0.0315 0.0285)
+(0.0000 0.0315 0.0285)
+(0.0030 0.0315 0.0285)
+(0.0060 0.0315 0.0285)
+(-0.0060 0.0345 0.0285)
+(-0.0030 0.0345 0.0285)
+(0.0000 0.0345 0.0285)
+(0.0030 0.0345 0.0285)
+(0.0060 0.0345 0.0285)
+(-0.0060 0.0375 0.0285)
+(-0.0030 0.0375 0.0285)
+(0.0000 0.0375 0.0285)
+(0.0030 0.0375 0.0285)
+(0.0060 0.0375 0.0285)
+(-0.0060 0.0405 0.0285)
+(-0.0030 0.0405 0.0285)
+(0.0000 0.0405 0.0285)
+(0.0030 0.0405 0.0285)
+(0.0060 0.0405 0.0285)
+(-0.0060 0.0435 0.0285)
+(-0.0030 0.0435 0.0285)
+(0.0000 0.0435 0.0285)
+(0.0030 0.0435 0.0285)
+(0.0060 0.0435 0.0285)
+(-0.0060 0.0465 0.0285)
+(-0.0030 0.0465 0.0285)
+(0.0000 0.0465 0.0285)
+(0.0030 0.0465 0.0285)
+(0.0060 0.0465 0.0285)
+(-0.0060 0.0495 0.0285)
+(-0.0030 0.0495 0.0285)
+(0.0000 0.0495 0.0285)
+(0.0030 0.0495 0.0285)
+(0.0060 0.0495 0.0285)
+(-0.0060 0.0525 0.0285)
+(-0.0030 0.0525 0.0285)
+(0.0000 0.0525 0.0285)
+(0.0030 0.0525 0.0285)
+(0.0060 0.0525 0.0285)
+(-0.0060 0.0555 0.0285)
+(-0.0030 0.0555 0.0285)
+(0.0000 0.0555 0.0285)
+(0.0030 0.0555 0.0285)
+(0.0060 0.0555 0.0285)
+(-0.0060 0.0585 0.0285)
+(-0.0030 0.0585 0.0285)
+(0.0000 0.0585 0.0285)
+(0.0030 0.0585 0.0285)
+(0.0060 0.0585 0.0285)
+(-0.0060 0.0615 0.0285)
+(-0.0030 0.0615 0.0285)
+(0.0000 0.0615 0.0285)
+(0.0030 0.0615 0.0285)
+(0.0060 0.0615 0.0285)
+(-0.0060 0.0645 0.0285)
+(-0.0030 0.0645 0.0285)
+(0.0000 0.0645 0.0285)
+(0.0030 0.0645 0.0285)
+(0.0060 0.0645 0.0285)
+(-0.0060 0.0675 0.0285)
+(-0.0030 0.0675 0.0285)
+(0.0000 0.0675 0.0285)
+(0.0030 0.0675 0.0285)
+(0.0060 0.0675 0.0285)
+(-0.0060 0.0705 0.0285)
+(-0.0030 0.0705 0.0285)
+(0.0000 0.0705 0.0285)
+(0.0030 0.0705 0.0285)
+(0.0060 0.0705 0.0285)
+(-0.0060 0.0735 0.0285)
+(-0.0030 0.0735 0.0285)
+(0.0000 0.0735 0.0285)
+(0.0030 0.0735 0.0285)
+(0.0060 0.0735 0.0285)
+(-0.0060 -0.0735 0.0315)
+(-0.0030 -0.0735 0.0315)
+(0.0000 -0.0735 0.0315)
+(0.0030 -0.0735 0.0315)
+(0.0060 -0.0735 0.0315)
+(-0.0060 -0.0705 0.0315)
+(-0.0030 -0.0705 0.0315)
+(0.0000 -0.0705 0.0315)
+(0.0030 -0.0705 0.0315)
+(0.0060 -0.0705 0.0315)
+(-0.0060 -0.0675 0.0315)
+(-0.0030 -0.0675 0.0315)
+(0.0000 -0.0675 0.0315)
+(0.0030 -0.0675 0.0315)
+(0.0060 -0.0675 0.0315)
+(-0.0060 -0.0645 0.0315)
+(-0.0030 -0.0645 0.0315)
+(0.0000 -0.0645 0.0315)
+(0.0030 -0.0645 0.0315)
+(0.0060 -0.0645 0.0315)
+(-0.0060 -0.0615 0.0315)
+(-0.0030 -0.0615 0.0315)
+(0.0000 -0.0615 0.0315)
+(0.0030 -0.0615 0.0315)
+(0.0060 -0.0615 0.0315)
+(-0.0060 -0.0585 0.0315)
+(-0.0030 -0.0585 0.0315)
+(0.0000 -0.0585 0.0315)
+(0.0030 -0.0585 0.0315)
+(0.0060 -0.0585 0.0315)
+(-0.0060 -0.0555 0.0315)
+(-0.0030 -0.0555 0.0315)
+(0.0000 -0.0555 0.0315)
+(0.0030 -0.0555 0.0315)
+(0.0060 -0.0555 0.0315)
+(-0.0060 -0.0525 0.0315)
+(-0.0030 -0.0525 0.0315)
+(0.0000 -0.0525 0.0315)
+(0.0030 -0.0525 0.0315)
+(0.0060 -0.0525 0.0315)
+(-0.0060 -0.0495 0.0315)
+(-0.0030 -0.0495 0.0315)
+(0.0000 -0.0495 0.0315)
+(0.0030 -0.0495 0.0315)
+(0.0060 -0.0495 0.0315)
+(-0.0060 -0.0465 0.0315)
+(-0.0030 -0.0465 0.0315)
+(0.0000 -0.0465 0.0315)
+(0.0030 -0.0465 0.0315)
+(0.0060 -0.0465 0.0315)
+(-0.0060 -0.0435 0.0315)
+(-0.0030 -0.0435 0.0315)
+(0.0000 -0.0435 0.0315)
+(0.0030 -0.0435 0.0315)
+(0.0060 -0.0435 0.0315)
+(-0.0060 -0.0405 0.0315)
+(-0.0030 -0.0405 0.0315)
+(0.0000 -0.0405 0.0315)
+(0.0030 -0.0405 0.0315)
+(0.0060 -0.0405 0.0315)
+(-0.0060 -0.0375 0.0315)
+(-0.0030 -0.0375 0.0315)
+(0.0000 -0.0375 0.0315)
+(0.0030 -0.0375 0.0315)
+(0.0060 -0.0375 0.0315)
+(-0.0060 -0.0345 0.0315)
+(-0.0030 -0.0345 0.0315)
+(0.0000 -0.0345 0.0315)
+(0.0030 -0.0345 0.0315)
+(0.0060 -0.0345 0.0315)
+(-0.0060 -0.0315 0.0315)
+(-0.0030 -0.0315 0.0315)
+(0.0000 -0.0315 0.0315)
+(0.0030 -0.0315 0.0315)
+(0.0060 -0.0315 0.0315)
+(-0.0060 -0.0285 0.0315)
+(-0.0030 -0.0285 0.0315)
+(0.0000 -0.0285 0.0315)
+(0.0030 -0.0285 0.0315)
+(0.0060 -0.0285 0.0315)
+(-0.0060 -0.0255 0.0315)
+(-0.0030 -0.0255 0.0315)
+(0.0000 -0.0255 0.0315)
+(0.0030 -0.0255 0.0315)
+(0.0060 -0.0255 0.0315)
+(-0.0060 -0.0225 0.0315)
+(-0.0030 -0.0225 0.0315)
+(0.0000 -0.0225 0.0315)
+(0.0030 -0.0225 0.0315)
+(0.0060 -0.0225 0.0315)
+(-0.0060 -0.0195 0.0315)
+(-0.0030 -0.0195 0.0315)
+(0.0000 -0.0195 0.0315)
+(0.0030 -0.0195 0.0315)
+(0.0060 -0.0195 0.0315)
+(-0.0060 -0.0165 0.0315)
+(-0.0030 -0.0165 0.0315)
+(0.0000 -0.0165 0.0315)
+(0.0030 -0.0165 0.0315)
+(0.0060 -0.0165 0.0315)
+(-0.0060 -0.0135 0.0315)
+(-0.0030 -0.0135 0.0315)
+(0.0000 -0.0135 0.0315)
+(0.0030 -0.0135 0.0315)
+(0.0060 -0.0135 0.0315)
+(-0.0060 -0.0105 0.0315)
+(-0.0030 -0.0105 0.0315)
+(0.0000 -0.0105 0.0315)
+(0.0030 -0.0105 0.0315)
+(0.0060 -0.0105 0.0315)
+(-0.0060 -0.0075 0.0315)
+(-0.0030 -0.0075 0.0315)
+(0.0000 -0.0075 0.0315)
+(0.0030 -0.0075 0.0315)
+(0.0060 -0.0075 0.0315)
+(-0.0060 -0.0045 0.0315)
+(-0.0030 -0.0045 0.0315)
+(0.0000 -0.0045 0.0315)
+(0.0030 -0.0045 0.0315)
+(0.0060 -0.0045 0.0315)
+(-0.0060 -0.0015 0.0315)
+(-0.0030 -0.0015 0.0315)
+(0.0000 -0.0015 0.0315)
+(0.0030 -0.0015 0.0315)
+(0.0060 -0.0015 0.0315)
+(-0.0060 0.0015 0.0315)
+(-0.0030 0.0015 0.0315)
+(0.0000 0.0015 0.0315)
+(0.0030 0.0015 0.0315)
+(0.0060 0.0015 0.0315)
+(-0.0060 0.0045 0.0315)
+(-0.0030 0.0045 0.0315)
+(0.0000 0.0045 0.0315)
+(0.0030 0.0045 0.0315)
+(0.0060 0.0045 0.0315)
+(-0.0060 0.0075 0.0315)
+(-0.0030 0.0075 0.0315)
+(0.0000 0.0075 0.0315)
+(0.0030 0.0075 0.0315)
+(0.0060 0.0075 0.0315)
+(-0.0060 0.0105 0.0315)
+(-0.0030 0.0105 0.0315)
+(0.0000 0.0105 0.0315)
+(0.0030 0.0105 0.0315)
+(0.0060 0.0105 0.0315)
+(-0.0060 0.0135 0.0315)
+(-0.0030 0.0135 0.0315)
+(0.0000 0.0135 0.0315)
+(0.0030 0.0135 0.0315)
+(0.0060 0.0135 0.0315)
+(-0.0060 0.0165 0.0315)
+(-0.0030 0.0165 0.0315)
+(0.0000 0.0165 0.0315)
+(0.0030 0.0165 0.0315)
+(0.0060 0.0165 0.0315)
+(-0.0060 0.0195 0.0315)
+(-0.0030 0.0195 0.0315)
+(0.0000 0.0195 0.0315)
+(0.0030 0.0195 0.0315)
+(0.0060 0.0195 0.0315)
+(-0.0060 0.0225 0.0315)
+(-0.0030 0.0225 0.0315)
+(0.0000 0.0225 0.0315)
+(0.0030 0.0225 0.0315)
+(0.0060 0.0225 0.0315)
+(-0.0060 0.0255 0.0315)
+(-0.0030 0.0255 0.0315)
+(0.0000 0.0255 0.0315)
+(0.0030 0.0255 0.0315)
+(0.0060 0.0255 0.0315)
+(-0.0060 0.0285 0.0315)
+(-0.0030 0.0285 0.0315)
+(0.0000 0.0285 0.0315)
+(0.0030 0.0285 0.0315)
+(0.0060 0.0285 0.0315)
+(-0.0060 0.0315 0.0315)
+(-0.0030 0.0315 0.0315)
+(0.0000 0.0315 0.0315)
+(0.0030 0.0315 0.0315)
+(0.0060 0.0315 0.0315)
+(-0.0060 0.0345 0.0315)
+(-0.0030 0.0345 0.0315)
+(0.0000 0.0345 0.0315)
+(0.0030 0.0345 0.0315)
+(0.0060 0.0345 0.0315)
+(-0.0060 0.0375 0.0315)
+(-0.0030 0.0375 0.0315)
+(0.0000 0.0375 0.0315)
+(0.0030 0.0375 0.0315)
+(0.0060 0.0375 0.0315)
+(-0.0060 0.0405 0.0315)
+(-0.0030 0.0405 0.0315)
+(0.0000 0.0405 0.0315)
+(0.0030 0.0405 0.0315)
+(0.0060 0.0405 0.0315)
+(-0.0060 0.0435 0.0315)
+(-0.0030 0.0435 0.0315)
+(0.0000 0.0435 0.0315)
+(0.0030 0.0435 0.0315)
+(0.0060 0.0435 0.0315)
+(-0.0060 0.0465 0.0315)
+(-0.0030 0.0465 0.0315)
+(0.0000 0.0465 0.0315)
+(0.0030 0.0465 0.0315)
+(0.0060 0.0465 0.0315)
+(-0.0060 0.0495 0.0315)
+(-0.0030 0.0495 0.0315)
+(0.0000 0.0495 0.0315)
+(0.0030 0.0495 0.0315)
+(0.0060 0.0495 0.0315)
+(-0.0060 0.0525 0.0315)
+(-0.0030 0.0525 0.0315)
+(0.0000 0.0525 0.0315)
+(0.0030 0.0525 0.0315)
+(0.0060 0.0525 0.0315)
+(-0.0060 0.0555 0.0315)
+(-0.0030 0.0555 0.0315)
+(0.0000 0.0555 0.0315)
+(0.0030 0.0555 0.0315)
+(0.0060 0.0555 0.0315)
+(-0.0060 0.0585 0.0315)
+(-0.0030 0.0585 0.0315)
+(0.0000 0.0585 0.0315)
+(0.0030 0.0585 0.0315)
+(0.0060 0.0585 0.0315)
+(-0.0060 0.0615 0.0315)
+(-0.0030 0.0615 0.0315)
+(0.0000 0.0615 0.0315)
+(0.0030 0.0615 0.0315)
+(0.0060 0.0615 0.0315)
+(-0.0060 0.0645 0.0315)
+(-0.0030 0.0645 0.0315)
+(0.0000 0.0645 0.0315)
+(0.0030 0.0645 0.0315)
+(0.0060 0.0645 0.0315)
+(-0.0060 0.0675 0.0315)
+(-0.0030 0.0675 0.0315)
+(0.0000 0.0675 0.0315)
+(0.0030 0.0675 0.0315)
+(0.0060 0.0675 0.0315)
+(-0.0060 0.0705 0.0315)
+(-0.0030 0.0705 0.0315)
+(0.0000 0.0705 0.0315)
+(0.0030 0.0705 0.0315)
+(0.0060 0.0705 0.0315)
+(-0.0060 0.0735 0.0315)
+(-0.0030 0.0735 0.0315)
+(0.0000 0.0735 0.0315)
+(0.0030 0.0735 0.0315)
+(0.0060 0.0735 0.0315)
+(-0.0060 -0.0735 0.0345)
+(-0.0030 -0.0735 0.0345)
+(0.0000 -0.0735 0.0345)
+(0.0030 -0.0735 0.0345)
+(0.0060 -0.0735 0.0345)
+(-0.0060 -0.0705 0.0345)
+(-0.0030 -0.0705 0.0345)
+(0.0000 -0.0705 0.0345)
+(0.0030 -0.0705 0.0345)
+(0.0060 -0.0705 0.0345)
+(-0.0060 -0.0675 0.0345)
+(-0.0030 -0.0675 0.0345)
+(0.0000 -0.0675 0.0345)
+(0.0030 -0.0675 0.0345)
+(0.0060 -0.0675 0.0345)
+(-0.0060 -0.0645 0.0345)
+(-0.0030 -0.0645 0.0345)
+(0.0000 -0.0645 0.0345)
+(0.0030 -0.0645 0.0345)
+(0.0060 -0.0645 0.0345)
+(-0.0060 -0.0615 0.0345)
+(-0.0030 -0.0615 0.0345)
+(0.0000 -0.0615 0.0345)
+(0.0030 -0.0615 0.0345)
+(0.0060 -0.0615 0.0345)
+(-0.0060 -0.0585 0.0345)
+(-0.0030 -0.0585 0.0345)
+(0.0000 -0.0585 0.0345)
+(0.0030 -0.0585 0.0345)
+(0.0060 -0.0585 0.0345)
+(-0.0060 -0.0555 0.0345)
+(-0.0030 -0.0555 0.0345)
+(0.0000 -0.0555 0.0345)
+(0.0030 -0.0555 0.0345)
+(0.0060 -0.0555 0.0345)
+(-0.0060 -0.0525 0.0345)
+(-0.0030 -0.0525 0.0345)
+(0.0000 -0.0525 0.0345)
+(0.0030 -0.0525 0.0345)
+(0.0060 -0.0525 0.0345)
+(-0.0060 -0.0495 0.0345)
+(-0.0030 -0.0495 0.0345)
+(0.0000 -0.0495 0.0345)
+(0.0030 -0.0495 0.0345)
+(0.0060 -0.0495 0.0345)
+(-0.0060 -0.0465 0.0345)
+(-0.0030 -0.0465 0.0345)
+(0.0000 -0.0465 0.0345)
+(0.0030 -0.0465 0.0345)
+(0.0060 -0.0465 0.0345)
+(-0.0060 -0.0435 0.0345)
+(-0.0030 -0.0435 0.0345)
+(0.0000 -0.0435 0.0345)
+(0.0030 -0.0435 0.0345)
+(0.0060 -0.0435 0.0345)
+(-0.0060 -0.0405 0.0345)
+(-0.0030 -0.0405 0.0345)
+(0.0000 -0.0405 0.0345)
+(0.0030 -0.0405 0.0345)
+(0.0060 -0.0405 0.0345)
+(-0.0060 -0.0375 0.0345)
+(-0.0030 -0.0375 0.0345)
+(0.0000 -0.0375 0.0345)
+(0.0030 -0.0375 0.0345)
+(0.0060 -0.0375 0.0345)
+(-0.0060 -0.0345 0.0345)
+(-0.0030 -0.0345 0.0345)
+(0.0000 -0.0345 0.0345)
+(0.0030 -0.0345 0.0345)
+(0.0060 -0.0345 0.0345)
+(-0.0060 -0.0315 0.0345)
+(-0.0030 -0.0315 0.0345)
+(0.0000 -0.0315 0.0345)
+(0.0030 -0.0315 0.0345)
+(0.0060 -0.0315 0.0345)
+(-0.0060 -0.0285 0.0345)
+(-0.0030 -0.0285 0.0345)
+(0.0000 -0.0285 0.0345)
+(0.0030 -0.0285 0.0345)
+(0.0060 -0.0285 0.0345)
+(-0.0060 -0.0255 0.0345)
+(-0.0030 -0.0255 0.0345)
+(0.0000 -0.0255 0.0345)
+(0.0030 -0.0255 0.0345)
+(0.0060 -0.0255 0.0345)
+(-0.0060 -0.0225 0.0345)
+(-0.0030 -0.0225 0.0345)
+(0.0000 -0.0225 0.0345)
+(0.0030 -0.0225 0.0345)
+(0.0060 -0.0225 0.0345)
+(-0.0060 -0.0195 0.0345)
+(-0.0030 -0.0195 0.0345)
+(0.0000 -0.0195 0.0345)
+(0.0030 -0.0195 0.0345)
+(0.0060 -0.0195 0.0345)
+(-0.0060 -0.0165 0.0345)
+(-0.0030 -0.0165 0.0345)
+(0.0000 -0.0165 0.0345)
+(0.0030 -0.0165 0.0345)
+(0.0060 -0.0165 0.0345)
+(-0.0060 -0.0135 0.0345)
+(-0.0030 -0.0135 0.0345)
+(0.0000 -0.0135 0.0345)
+(0.0030 -0.0135 0.0345)
+(0.0060 -0.0135 0.0345)
+(-0.0060 -0.0105 0.0345)
+(-0.0030 -0.0105 0.0345)
+(0.0000 -0.0105 0.0345)
+(0.0030 -0.0105 0.0345)
+(0.0060 -0.0105 0.0345)
+(-0.0060 -0.0075 0.0345)
+(-0.0030 -0.0075 0.0345)
+(0.0000 -0.0075 0.0345)
+(0.0030 -0.0075 0.0345)
+(0.0060 -0.0075 0.0345)
+(-0.0060 -0.0045 0.0345)
+(-0.0030 -0.0045 0.0345)
+(0.0000 -0.0045 0.0345)
+(0.0030 -0.0045 0.0345)
+(0.0060 -0.0045 0.0345)
+(-0.0060 -0.0015 0.0345)
+(-0.0030 -0.0015 0.0345)
+(0.0000 -0.0015 0.0345)
+(0.0030 -0.0015 0.0345)
+(0.0060 -0.0015 0.0345)
+(-0.0060 0.0015 0.0345)
+(-0.0030 0.0015 0.0345)
+(0.0000 0.0015 0.0345)
+(0.0030 0.0015 0.0345)
+(0.0060 0.0015 0.0345)
+(-0.0060 0.0045 0.0345)
+(-0.0030 0.0045 0.0345)
+(0.0000 0.0045 0.0345)
+(0.0030 0.0045 0.0345)
+(0.0060 0.0045 0.0345)
+(-0.0060 0.0075 0.0345)
+(-0.0030 0.0075 0.0345)
+(0.0000 0.0075 0.0345)
+(0.0030 0.0075 0.0345)
+(0.0060 0.0075 0.0345)
+(-0.0060 0.0105 0.0345)
+(-0.0030 0.0105 0.0345)
+(0.0000 0.0105 0.0345)
+(0.0030 0.0105 0.0345)
+(0.0060 0.0105 0.0345)
+(-0.0060 0.0135 0.0345)
+(-0.0030 0.0135 0.0345)
+(0.0000 0.0135 0.0345)
+(0.0030 0.0135 0.0345)
+(0.0060 0.0135 0.0345)
+(-0.0060 0.0165 0.0345)
+(-0.0030 0.0165 0.0345)
+(0.0000 0.0165 0.0345)
+(0.0030 0.0165 0.0345)
+(0.0060 0.0165 0.0345)
+(-0.0060 0.0195 0.0345)
+(-0.0030 0.0195 0.0345)
+(0.0000 0.0195 0.0345)
+(0.0030 0.0195 0.0345)
+(0.0060 0.0195 0.0345)
+(-0.0060 0.0225 0.0345)
+(-0.0030 0.0225 0.0345)
+(0.0000 0.0225 0.0345)
+(0.0030 0.0225 0.0345)
+(0.0060 0.0225 0.0345)
+(-0.0060 0.0255 0.0345)
+(-0.0030 0.0255 0.0345)
+(0.0000 0.0255 0.0345)
+(0.0030 0.0255 0.0345)
+(0.0060 0.0255 0.0345)
+(-0.0060 0.0285 0.0345)
+(-0.0030 0.0285 0.0345)
+(0.0000 0.0285 0.0345)
+(0.0030 0.0285 0.0345)
+(0.0060 0.0285 0.0345)
+(-0.0060 0.0315 0.0345)
+(-0.0030 0.0315 0.0345)
+(0.0000 0.0315 0.0345)
+(0.0030 0.0315 0.0345)
+(0.0060 0.0315 0.0345)
+(-0.0060 0.0345 0.0345)
+(-0.0030 0.0345 0.0345)
+(0.0000 0.0345 0.0345)
+(0.0030 0.0345 0.0345)
+(0.0060 0.0345 0.0345)
+(-0.0060 0.0375 0.0345)
+(-0.0030 0.0375 0.0345)
+(0.0000 0.0375 0.0345)
+(0.0030 0.0375 0.0345)
+(0.0060 0.0375 0.0345)
+(-0.0060 0.0405 0.0345)
+(-0.0030 0.0405 0.0345)
+(0.0000 0.0405 0.0345)
+(0.0030 0.0405 0.0345)
+(0.0060 0.0405 0.0345)
+(-0.0060 0.0435 0.0345)
+(-0.0030 0.0435 0.0345)
+(0.0000 0.0435 0.0345)
+(0.0030 0.0435 0.0345)
+(0.0060 0.0435 0.0345)
+(-0.0060 0.0465 0.0345)
+(-0.0030 0.0465 0.0345)
+(0.0000 0.0465 0.0345)
+(0.0030 0.0465 0.0345)
+(0.0060 0.0465 0.0345)
+(-0.0060 0.0495 0.0345)
+(-0.0030 0.0495 0.0345)
+(0.0000 0.0495 0.0345)
+(0.0030 0.0495 0.0345)
+(0.0060 0.0495 0.0345)
+(-0.0060 0.0525 0.0345)
+(-0.0030 0.0525 0.0345)
+(0.0000 0.0525 0.0345)
+(0.0030 0.0525 0.0345)
+(0.0060 0.0525 0.0345)
+(-0.0060 0.0555 0.0345)
+(-0.0030 0.0555 0.0345)
+(0.0000 0.0555 0.0345)
+(0.0030 0.0555 0.0345)
+(0.0060 0.0555 0.0345)
+(-0.0060 0.0585 0.0345)
+(-0.0030 0.0585 0.0345)
+(0.0000 0.0585 0.0345)
+(0.0030 0.0585 0.0345)
+(0.0060 0.0585 0.0345)
+(-0.0060 0.0615 0.0345)
+(-0.0030 0.0615 0.0345)
+(0.0000 0.0615 0.0345)
+(0.0030 0.0615 0.0345)
+(0.0060 0.0615 0.0345)
+(-0.0060 0.0645 0.0345)
+(-0.0030 0.0645 0.0345)
+(0.0000 0.0645 0.0345)
+(0.0030 0.0645 0.0345)
+(0.0060 0.0645 0.0345)
+(-0.0060 0.0675 0.0345)
+(-0.0030 0.0675 0.0345)
+(0.0000 0.0675 0.0345)
+(0.0030 0.0675 0.0345)
+(0.0060 0.0675 0.0345)
+(-0.0060 0.0705 0.0345)
+(-0.0030 0.0705 0.0345)
+(0.0000 0.0705 0.0345)
+(0.0030 0.0705 0.0345)
+(0.0060 0.0705 0.0345)
+(-0.0060 0.0735 0.0345)
+(-0.0030 0.0735 0.0345)
+(0.0000 0.0735 0.0345)
+(0.0030 0.0735 0.0345)
+(0.0060 0.0735 0.0345)
+(-0.0060 -0.0735 0.0375)
+(-0.0030 -0.0735 0.0375)
+(0.0000 -0.0735 0.0375)
+(0.0030 -0.0735 0.0375)
+(0.0060 -0.0735 0.0375)
+(-0.0060 -0.0705 0.0375)
+(-0.0030 -0.0705 0.0375)
+(0.0000 -0.0705 0.0375)
+(0.0030 -0.0705 0.0375)
+(0.0060 -0.0705 0.0375)
+(-0.0060 -0.0675 0.0375)
+(-0.0030 -0.0675 0.0375)
+(0.0000 -0.0675 0.0375)
+(0.0030 -0.0675 0.0375)
+(0.0060 -0.0675 0.0375)
+(-0.0060 -0.0645 0.0375)
+(-0.0030 -0.0645 0.0375)
+(0.0000 -0.0645 0.0375)
+(0.0030 -0.0645 0.0375)
+(0.0060 -0.0645 0.0375)
+(-0.0060 -0.0615 0.0375)
+(-0.0030 -0.0615 0.0375)
+(0.0000 -0.0615 0.0375)
+(0.0030 -0.0615 0.0375)
+(0.0060 -0.0615 0.0375)
+(-0.0060 -0.0585 0.0375)
+(-0.0030 -0.0585 0.0375)
+(0.0000 -0.0585 0.0375)
+(0.0030 -0.0585 0.0375)
+(0.0060 -0.0585 0.0375)
+(-0.0060 -0.0555 0.0375)
+(-0.0030 -0.0555 0.0375)
+(0.0000 -0.0555 0.0375)
+(0.0030 -0.0555 0.0375)
+(0.0060 -0.0555 0.0375)
+(-0.0060 -0.0525 0.0375)
+(-0.0030 -0.0525 0.0375)
+(0.0000 -0.0525 0.0375)
+(0.0030 -0.0525 0.0375)
+(0.0060 -0.0525 0.0375)
+(-0.0060 -0.0495 0.0375)
+(-0.0030 -0.0495 0.0375)
+(0.0000 -0.0495 0.0375)
+(0.0030 -0.0495 0.0375)
+(0.0060 -0.0495 0.0375)
+(-0.0060 -0.0465 0.0375)
+(-0.0030 -0.0465 0.0375)
+(0.0000 -0.0465 0.0375)
+(0.0030 -0.0465 0.0375)
+(0.0060 -0.0465 0.0375)
+(-0.0060 -0.0435 0.0375)
+(-0.0030 -0.0435 0.0375)
+(0.0000 -0.0435 0.0375)
+(0.0030 -0.0435 0.0375)
+(0.0060 -0.0435 0.0375)
+(-0.0060 -0.0405 0.0375)
+(-0.0030 -0.0405 0.0375)
+(0.0000 -0.0405 0.0375)
+(0.0030 -0.0405 0.0375)
+(0.0060 -0.0405 0.0375)
+(-0.0060 -0.0375 0.0375)
+(-0.0030 -0.0375 0.0375)
+(0.0000 -0.0375 0.0375)
+(0.0030 -0.0375 0.0375)
+(0.0060 -0.0375 0.0375)
+(-0.0060 -0.0345 0.0375)
+(-0.0030 -0.0345 0.0375)
+(0.0000 -0.0345 0.0375)
+(0.0030 -0.0345 0.0375)
+(0.0060 -0.0345 0.0375)
+(-0.0060 -0.0315 0.0375)
+(-0.0030 -0.0315 0.0375)
+(0.0000 -0.0315 0.0375)
+(0.0030 -0.0315 0.0375)
+(0.0060 -0.0315 0.0375)
+(-0.0060 -0.0285 0.0375)
+(-0.0030 -0.0285 0.0375)
+(0.0000 -0.0285 0.0375)
+(0.0030 -0.0285 0.0375)
+(0.0060 -0.0285 0.0375)
+(-0.0060 -0.0255 0.0375)
+(-0.0030 -0.0255 0.0375)
+(0.0000 -0.0255 0.0375)
+(0.0030 -0.0255 0.0375)
+(0.0060 -0.0255 0.0375)
+(-0.0060 -0.0225 0.0375)
+(-0.0030 -0.0225 0.0375)
+(0.0000 -0.0225 0.0375)
+(0.0030 -0.0225 0.0375)
+(0.0060 -0.0225 0.0375)
+(-0.0060 -0.0195 0.0375)
+(-0.0030 -0.0195 0.0375)
+(0.0000 -0.0195 0.0375)
+(0.0030 -0.0195 0.0375)
+(0.0060 -0.0195 0.0375)
+(-0.0060 -0.0165 0.0375)
+(-0.0030 -0.0165 0.0375)
+(0.0000 -0.0165 0.0375)
+(0.0030 -0.0165 0.0375)
+(0.0060 -0.0165 0.0375)
+(-0.0060 -0.0135 0.0375)
+(-0.0030 -0.0135 0.0375)
+(0.0000 -0.0135 0.0375)
+(0.0030 -0.0135 0.0375)
+(0.0060 -0.0135 0.0375)
+(-0.0060 -0.0105 0.0375)
+(-0.0030 -0.0105 0.0375)
+(0.0000 -0.0105 0.0375)
+(0.0030 -0.0105 0.0375)
+(0.0060 -0.0105 0.0375)
+(-0.0060 -0.0075 0.0375)
+(-0.0030 -0.0075 0.0375)
+(0.0000 -0.0075 0.0375)
+(0.0030 -0.0075 0.0375)
+(0.0060 -0.0075 0.0375)
+(-0.0060 -0.0045 0.0375)
+(-0.0030 -0.0045 0.0375)
+(0.0000 -0.0045 0.0375)
+(0.0030 -0.0045 0.0375)
+(0.0060 -0.0045 0.0375)
+(-0.0060 -0.0015 0.0375)
+(-0.0030 -0.0015 0.0375)
+(0.0000 -0.0015 0.0375)
+(0.0030 -0.0015 0.0375)
+(0.0060 -0.0015 0.0375)
+(-0.0060 0.0015 0.0375)
+(-0.0030 0.0015 0.0375)
+(0.0000 0.0015 0.0375)
+(0.0030 0.0015 0.0375)
+(0.0060 0.0015 0.0375)
+(-0.0060 0.0045 0.0375)
+(-0.0030 0.0045 0.0375)
+(0.0000 0.0045 0.0375)
+(0.0030 0.0045 0.0375)
+(0.0060 0.0045 0.0375)
+(-0.0060 0.0075 0.0375)
+(-0.0030 0.0075 0.0375)
+(0.0000 0.0075 0.0375)
+(0.0030 0.0075 0.0375)
+(0.0060 0.0075 0.0375)
+(-0.0060 0.0105 0.0375)
+(-0.0030 0.0105 0.0375)
+(0.0000 0.0105 0.0375)
+(0.0030 0.0105 0.0375)
+(0.0060 0.0105 0.0375)
+(-0.0060 0.0135 0.0375)
+(-0.0030 0.0135 0.0375)
+(0.0000 0.0135 0.0375)
+(0.0030 0.0135 0.0375)
+(0.0060 0.0135 0.0375)
+(-0.0060 0.0165 0.0375)
+(-0.0030 0.0165 0.0375)
+(0.0000 0.0165 0.0375)
+(0.0030 0.0165 0.0375)
+(0.0060 0.0165 0.0375)
+(-0.0060 0.0195 0.0375)
+(-0.0030 0.0195 0.0375)
+(0.0000 0.0195 0.0375)
+(0.0030 0.0195 0.0375)
+(0.0060 0.0195 0.0375)
+(-0.0060 0.0225 0.0375)
+(-0.0030 0.0225 0.0375)
+(0.0000 0.0225 0.0375)
+(0.0030 0.0225 0.0375)
+(0.0060 0.0225 0.0375)
+(-0.0060 0.0255 0.0375)
+(-0.0030 0.0255 0.0375)
+(0.0000 0.0255 0.0375)
+(0.0030 0.0255 0.0375)
+(0.0060 0.0255 0.0375)
+(-0.0060 0.0285 0.0375)
+(-0.0030 0.0285 0.0375)
+(0.0000 0.0285 0.0375)
+(0.0030 0.0285 0.0375)
+(0.0060 0.0285 0.0375)
+(-0.0060 0.0315 0.0375)
+(-0.0030 0.0315 0.0375)
+(0.0000 0.0315 0.0375)
+(0.0030 0.0315 0.0375)
+(0.0060 0.0315 0.0375)
+(-0.0060 0.0345 0.0375)
+(-0.0030 0.0345 0.0375)
+(0.0000 0.0345 0.0375)
+(0.0030 0.0345 0.0375)
+(0.0060 0.0345 0.0375)
+(-0.0060 0.0375 0.0375)
+(-0.0030 0.0375 0.0375)
+(0.0000 0.0375 0.0375)
+(0.0030 0.0375 0.0375)
+(0.0060 0.0375 0.0375)
+(-0.0060 0.0405 0.0375)
+(-0.0030 0.0405 0.0375)
+(0.0000 0.0405 0.0375)
+(0.0030 0.0405 0.0375)
+(0.0060 0.0405 0.0375)
+(-0.0060 0.0435 0.0375)
+(-0.0030 0.0435 0.0375)
+(0.0000 0.0435 0.0375)
+(0.0030 0.0435 0.0375)
+(0.0060 0.0435 0.0375)
+(-0.0060 0.0465 0.0375)
+(-0.0030 0.0465 0.0375)
+(0.0000 0.0465 0.0375)
+(0.0030 0.0465 0.0375)
+(0.0060 0.0465 0.0375)
+(-0.0060 0.0495 0.0375)
+(-0.0030 0.0495 0.0375)
+(0.0000 0.0495 0.0375)
+(0.0030 0.0495 0.0375)
+(0.0060 0.0495 0.0375)
+(-0.0060 0.0525 0.0375)
+(-0.0030 0.0525 0.0375)
+(0.0000 0.0525 0.0375)
+(0.0030 0.0525 0.0375)
+(0.0060 0.0525 0.0375)
+(-0.0060 0.0555 0.0375)
+(-0.0030 0.0555 0.0375)
+(0.0000 0.0555 0.0375)
+(0.0030 0.0555 0.0375)
+(0.0060 0.0555 0.0375)
+(-0.0060 0.0585 0.0375)
+(-0.0030 0.0585 0.0375)
+(0.0000 0.0585 0.0375)
+(0.0030 0.0585 0.0375)
+(0.0060 0.0585 0.0375)
+(-0.0060 0.0615 0.0375)
+(-0.0030 0.0615 0.0375)
+(0.0000 0.0615 0.0375)
+(0.0030 0.0615 0.0375)
+(0.0060 0.0615 0.0375)
+(-0.0060 0.0645 0.0375)
+(-0.0030 0.0645 0.0375)
+(0.0000 0.0645 0.0375)
+(0.0030 0.0645 0.0375)
+(0.0060 0.0645 0.0375)
+(-0.0060 0.0675 0.0375)
+(-0.0030 0.0675 0.0375)
+(0.0000 0.0675 0.0375)
+(0.0030 0.0675 0.0375)
+(0.0060 0.0675 0.0375)
+(-0.0060 0.0705 0.0375)
+(-0.0030 0.0705 0.0375)
+(0.0000 0.0705 0.0375)
+(0.0030 0.0705 0.0375)
+(0.0060 0.0705 0.0375)
+(-0.0060 0.0735 0.0375)
+(-0.0030 0.0735 0.0375)
+(0.0000 0.0735 0.0375)
+(0.0030 0.0735 0.0375)
+(0.0060 0.0735 0.0375)
+(-0.0060 -0.0735 0.0405)
+(-0.0030 -0.0735 0.0405)
+(0.0000 -0.0735 0.0405)
+(0.0030 -0.0735 0.0405)
+(0.0060 -0.0735 0.0405)
+(-0.0060 -0.0705 0.0405)
+(-0.0030 -0.0705 0.0405)
+(0.0000 -0.0705 0.0405)
+(0.0030 -0.0705 0.0405)
+(0.0060 -0.0705 0.0405)
+(-0.0060 -0.0675 0.0405)
+(-0.0030 -0.0675 0.0405)
+(0.0000 -0.0675 0.0405)
+(0.0030 -0.0675 0.0405)
+(0.0060 -0.0675 0.0405)
+(-0.0060 -0.0645 0.0405)
+(-0.0030 -0.0645 0.0405)
+(0.0000 -0.0645 0.0405)
+(0.0030 -0.0645 0.0405)
+(0.0060 -0.0645 0.0405)
+(-0.0060 -0.0615 0.0405)
+(-0.0030 -0.0615 0.0405)
+(0.0000 -0.0615 0.0405)
+(0.0030 -0.0615 0.0405)
+(0.0060 -0.0615 0.0405)
+(-0.0060 -0.0585 0.0405)
+(-0.0030 -0.0585 0.0405)
+(0.0000 -0.0585 0.0405)
+(0.0030 -0.0585 0.0405)
+(0.0060 -0.0585 0.0405)
+(-0.0060 -0.0555 0.0405)
+(-0.0030 -0.0555 0.0405)
+(0.0000 -0.0555 0.0405)
+(0.0030 -0.0555 0.0405)
+(0.0060 -0.0555 0.0405)
+(-0.0060 -0.0525 0.0405)
+(-0.0030 -0.0525 0.0405)
+(0.0000 -0.0525 0.0405)
+(0.0030 -0.0525 0.0405)
+(0.0060 -0.0525 0.0405)
+(-0.0060 -0.0495 0.0405)
+(-0.0030 -0.0495 0.0405)
+(0.0000 -0.0495 0.0405)
+(0.0030 -0.0495 0.0405)
+(0.0060 -0.0495 0.0405)
+(-0.0060 -0.0465 0.0405)
+(-0.0030 -0.0465 0.0405)
+(0.0000 -0.0465 0.0405)
+(0.0030 -0.0465 0.0405)
+(0.0060 -0.0465 0.0405)
+(-0.0060 -0.0435 0.0405)
+(-0.0030 -0.0435 0.0405)
+(0.0000 -0.0435 0.0405)
+(0.0030 -0.0435 0.0405)
+(0.0060 -0.0435 0.0405)
+(-0.0060 -0.0405 0.0405)
+(-0.0030 -0.0405 0.0405)
+(0.0000 -0.0405 0.0405)
+(0.0030 -0.0405 0.0405)
+(0.0060 -0.0405 0.0405)
+(-0.0060 -0.0375 0.0405)
+(-0.0030 -0.0375 0.0405)
+(0.0000 -0.0375 0.0405)
+(0.0030 -0.0375 0.0405)
+(0.0060 -0.0375 0.0405)
+(-0.0060 -0.0345 0.0405)
+(-0.0030 -0.0345 0.0405)
+(0.0000 -0.0345 0.0405)
+(0.0030 -0.0345 0.0405)
+(0.0060 -0.0345 0.0405)
+(-0.0060 -0.0315 0.0405)
+(-0.0030 -0.0315 0.0405)
+(0.0000 -0.0315 0.0405)
+(0.0030 -0.0315 0.0405)
+(0.0060 -0.0315 0.0405)
+(-0.0060 -0.0285 0.0405)
+(-0.0030 -0.0285 0.0405)
+(0.0000 -0.0285 0.0405)
+(0.0030 -0.0285 0.0405)
+(0.0060 -0.0285 0.0405)
+(-0.0060 -0.0255 0.0405)
+(-0.0030 -0.0255 0.0405)
+(0.0000 -0.0255 0.0405)
+(0.0030 -0.0255 0.0405)
+(0.0060 -0.0255 0.0405)
+(-0.0060 -0.0225 0.0405)
+(-0.0030 -0.0225 0.0405)
+(0.0000 -0.0225 0.0405)
+(0.0030 -0.0225 0.0405)
+(0.0060 -0.0225 0.0405)
+(-0.0060 -0.0195 0.0405)
+(-0.0030 -0.0195 0.0405)
+(0.0000 -0.0195 0.0405)
+(0.0030 -0.0195 0.0405)
+(0.0060 -0.0195 0.0405)
+(-0.0060 -0.0165 0.0405)
+(-0.0030 -0.0165 0.0405)
+(0.0000 -0.0165 0.0405)
+(0.0030 -0.0165 0.0405)
+(0.0060 -0.0165 0.0405)
+(-0.0060 -0.0135 0.0405)
+(-0.0030 -0.0135 0.0405)
+(0.0000 -0.0135 0.0405)
+(0.0030 -0.0135 0.0405)
+(0.0060 -0.0135 0.0405)
+(-0.0060 -0.0105 0.0405)
+(-0.0030 -0.0105 0.0405)
+(0.0000 -0.0105 0.0405)
+(0.0030 -0.0105 0.0405)
+(0.0060 -0.0105 0.0405)
+(-0.0060 -0.0075 0.0405)
+(-0.0030 -0.0075 0.0405)
+(0.0000 -0.0075 0.0405)
+(0.0030 -0.0075 0.0405)
+(0.0060 -0.0075 0.0405)
+(-0.0060 -0.0045 0.0405)
+(-0.0030 -0.0045 0.0405)
+(0.0000 -0.0045 0.0405)
+(0.0030 -0.0045 0.0405)
+(0.0060 -0.0045 0.0405)
+(-0.0060 -0.0015 0.0405)
+(-0.0030 -0.0015 0.0405)
+(0.0000 -0.0015 0.0405)
+(0.0030 -0.0015 0.0405)
+(0.0060 -0.0015 0.0405)
+(-0.0060 0.0015 0.0405)
+(-0.0030 0.0015 0.0405)
+(0.0000 0.0015 0.0405)
+(0.0030 0.0015 0.0405)
+(0.0060 0.0015 0.0405)
+(-0.0060 0.0045 0.0405)
+(-0.0030 0.0045 0.0405)
+(0.0000 0.0045 0.0405)
+(0.0030 0.0045 0.0405)
+(0.0060 0.0045 0.0405)
+(-0.0060 0.0075 0.0405)
+(-0.0030 0.0075 0.0405)
+(0.0000 0.0075 0.0405)
+(0.0030 0.0075 0.0405)
+(0.0060 0.0075 0.0405)
+(-0.0060 0.0105 0.0405)
+(-0.0030 0.0105 0.0405)
+(0.0000 0.0105 0.0405)
+(0.0030 0.0105 0.0405)
+(0.0060 0.0105 0.0405)
+(-0.0060 0.0135 0.0405)
+(-0.0030 0.0135 0.0405)
+(0.0000 0.0135 0.0405)
+(0.0030 0.0135 0.0405)
+(0.0060 0.0135 0.0405)
+(-0.0060 0.0165 0.0405)
+(-0.0030 0.0165 0.0405)
+(0.0000 0.0165 0.0405)
+(0.0030 0.0165 0.0405)
+(0.0060 0.0165 0.0405)
+(-0.0060 0.0195 0.0405)
+(-0.0030 0.0195 0.0405)
+(0.0000 0.0195 0.0405)
+(0.0030 0.0195 0.0405)
+(0.0060 0.0195 0.0405)
+(-0.0060 0.0225 0.0405)
+(-0.0030 0.0225 0.0405)
+(0.0000 0.0225 0.0405)
+(0.0030 0.0225 0.0405)
+(0.0060 0.0225 0.0405)
+(-0.0060 0.0255 0.0405)
+(-0.0030 0.0255 0.0405)
+(0.0000 0.0255 0.0405)
+(0.0030 0.0255 0.0405)
+(0.0060 0.0255 0.0405)
+(-0.0060 0.0285 0.0405)
+(-0.0030 0.0285 0.0405)
+(0.0000 0.0285 0.0405)
+(0.0030 0.0285 0.0405)
+(0.0060 0.0285 0.0405)
+(-0.0060 0.0315 0.0405)
+(-0.0030 0.0315 0.0405)
+(0.0000 0.0315 0.0405)
+(0.0030 0.0315 0.0405)
+(0.0060 0.0315 0.0405)
+(-0.0060 0.0345 0.0405)
+(-0.0030 0.0345 0.0405)
+(0.0000 0.0345 0.0405)
+(0.0030 0.0345 0.0405)
+(0.0060 0.0345 0.0405)
+(-0.0060 0.0375 0.0405)
+(-0.0030 0.0375 0.0405)
+(0.0000 0.0375 0.0405)
+(0.0030 0.0375 0.0405)
+(0.0060 0.0375 0.0405)
+(-0.0060 0.0405 0.0405)
+(-0.0030 0.0405 0.0405)
+(0.0000 0.0405 0.0405)
+(0.0030 0.0405 0.0405)
+(0.0060 0.0405 0.0405)
+(-0.0060 0.0435 0.0405)
+(-0.0030 0.0435 0.0405)
+(0.0000 0.0435 0.0405)
+(0.0030 0.0435 0.0405)
+(0.0060 0.0435 0.0405)
+(-0.0060 0.0465 0.0405)
+(-0.0030 0.0465 0.0405)
+(0.0000 0.0465 0.0405)
+(0.0030 0.0465 0.0405)
+(0.0060 0.0465 0.0405)
+(-0.0060 0.0495 0.0405)
+(-0.0030 0.0495 0.0405)
+(0.0000 0.0495 0.0405)
+(0.0030 0.0495 0.0405)
+(0.0060 0.0495 0.0405)
+(-0.0060 0.0525 0.0405)
+(-0.0030 0.0525 0.0405)
+(0.0000 0.0525 0.0405)
+(0.0030 0.0525 0.0405)
+(0.0060 0.0525 0.0405)
+(-0.0060 0.0555 0.0405)
+(-0.0030 0.0555 0.0405)
+(0.0000 0.0555 0.0405)
+(0.0030 0.0555 0.0405)
+(0.0060 0.0555 0.0405)
+(-0.0060 0.0585 0.0405)
+(-0.0030 0.0585 0.0405)
+(0.0000 0.0585 0.0405)
+(0.0030 0.0585 0.0405)
+(0.0060 0.0585 0.0405)
+(-0.0060 0.0615 0.0405)
+(-0.0030 0.0615 0.0405)
+(0.0000 0.0615 0.0405)
+(0.0030 0.0615 0.0405)
+(0.0060 0.0615 0.0405)
+(-0.0060 0.0645 0.0405)
+(-0.0030 0.0645 0.0405)
+(0.0000 0.0645 0.0405)
+(0.0030 0.0645 0.0405)
+(0.0060 0.0645 0.0405)
+(-0.0060 0.0675 0.0405)
+(-0.0030 0.0675 0.0405)
+(0.0000 0.0675 0.0405)
+(0.0030 0.0675 0.0405)
+(0.0060 0.0675 0.0405)
+(-0.0060 0.0705 0.0405)
+(-0.0030 0.0705 0.0405)
+(0.0000 0.0705 0.0405)
+(0.0030 0.0705 0.0405)
+(0.0060 0.0705 0.0405)
+(-0.0060 0.0735 0.0405)
+(-0.0030 0.0735 0.0405)
+(0.0000 0.0735 0.0405)
+(0.0030 0.0735 0.0405)
+(0.0060 0.0735 0.0405)
+(-0.0060 -0.0735 0.0435)
+(-0.0030 -0.0735 0.0435)
+(0.0000 -0.0735 0.0435)
+(0.0030 -0.0735 0.0435)
+(0.0060 -0.0735 0.0435)
+(-0.0060 -0.0705 0.0435)
+(-0.0030 -0.0705 0.0435)
+(0.0000 -0.0705 0.0435)
+(0.0030 -0.0705 0.0435)
+(0.0060 -0.0705 0.0435)
+(-0.0060 -0.0675 0.0435)
+(-0.0030 -0.0675 0.0435)
+(0.0000 -0.0675 0.0435)
+(0.0030 -0.0675 0.0435)
+(0.0060 -0.0675 0.0435)
+(-0.0060 -0.0645 0.0435)
+(-0.0030 -0.0645 0.0435)
+(0.0000 -0.0645 0.0435)
+(0.0030 -0.0645 0.0435)
+(0.0060 -0.0645 0.0435)
+(-0.0060 -0.0615 0.0435)
+(-0.0030 -0.0615 0.0435)
+(0.0000 -0.0615 0.0435)
+(0.0030 -0.0615 0.0435)
+(0.0060 -0.0615 0.0435)
+(-0.0060 -0.0585 0.0435)
+(-0.0030 -0.0585 0.0435)
+(0.0000 -0.0585 0.0435)
+(0.0030 -0.0585 0.0435)
+(0.0060 -0.0585 0.0435)
+(-0.0060 -0.0555 0.0435)
+(-0.0030 -0.0555 0.0435)
+(0.0000 -0.0555 0.0435)
+(0.0030 -0.0555 0.0435)
+(0.0060 -0.0555 0.0435)
+(-0.0060 -0.0525 0.0435)
+(-0.0030 -0.0525 0.0435)
+(0.0000 -0.0525 0.0435)
+(0.0030 -0.0525 0.0435)
+(0.0060 -0.0525 0.0435)
+(-0.0060 -0.0495 0.0435)
+(-0.0030 -0.0495 0.0435)
+(0.0000 -0.0495 0.0435)
+(0.0030 -0.0495 0.0435)
+(0.0060 -0.0495 0.0435)
+(-0.0060 -0.0465 0.0435)
+(-0.0030 -0.0465 0.0435)
+(0.0000 -0.0465 0.0435)
+(0.0030 -0.0465 0.0435)
+(0.0060 -0.0465 0.0435)
+(-0.0060 -0.0435 0.0435)
+(-0.0030 -0.0435 0.0435)
+(0.0000 -0.0435 0.0435)
+(0.0030 -0.0435 0.0435)
+(0.0060 -0.0435 0.0435)
+(-0.0060 -0.0405 0.0435)
+(-0.0030 -0.0405 0.0435)
+(0.0000 -0.0405 0.0435)
+(0.0030 -0.0405 0.0435)
+(0.0060 -0.0405 0.0435)
+(-0.0060 -0.0375 0.0435)
+(-0.0030 -0.0375 0.0435)
+(0.0000 -0.0375 0.0435)
+(0.0030 -0.0375 0.0435)
+(0.0060 -0.0375 0.0435)
+(-0.0060 -0.0345 0.0435)
+(-0.0030 -0.0345 0.0435)
+(0.0000 -0.0345 0.0435)
+(0.0030 -0.0345 0.0435)
+(0.0060 -0.0345 0.0435)
+(-0.0060 -0.0315 0.0435)
+(-0.0030 -0.0315 0.0435)
+(0.0000 -0.0315 0.0435)
+(0.0030 -0.0315 0.0435)
+(0.0060 -0.0315 0.0435)
+(-0.0060 -0.0285 0.0435)
+(-0.0030 -0.0285 0.0435)
+(0.0000 -0.0285 0.0435)
+(0.0030 -0.0285 0.0435)
+(0.0060 -0.0285 0.0435)
+(-0.0060 -0.0255 0.0435)
+(-0.0030 -0.0255 0.0435)
+(0.0000 -0.0255 0.0435)
+(0.0030 -0.0255 0.0435)
+(0.0060 -0.0255 0.0435)
+(-0.0060 -0.0225 0.0435)
+(-0.0030 -0.0225 0.0435)
+(0.0000 -0.0225 0.0435)
+(0.0030 -0.0225 0.0435)
+(0.0060 -0.0225 0.0435)
+(-0.0060 -0.0195 0.0435)
+(-0.0030 -0.0195 0.0435)
+(0.0000 -0.0195 0.0435)
+(0.0030 -0.0195 0.0435)
+(0.0060 -0.0195 0.0435)
+(-0.0060 -0.0165 0.0435)
+(-0.0030 -0.0165 0.0435)
+(0.0000 -0.0165 0.0435)
+(0.0030 -0.0165 0.0435)
+(0.0060 -0.0165 0.0435)
+(-0.0060 -0.0135 0.0435)
+(-0.0030 -0.0135 0.0435)
+(0.0000 -0.0135 0.0435)
+(0.0030 -0.0135 0.0435)
+(0.0060 -0.0135 0.0435)
+(-0.0060 -0.0105 0.0435)
+(-0.0030 -0.0105 0.0435)
+(0.0000 -0.0105 0.0435)
+(0.0030 -0.0105 0.0435)
+(0.0060 -0.0105 0.0435)
+(-0.0060 -0.0075 0.0435)
+(-0.0030 -0.0075 0.0435)
+(0.0000 -0.0075 0.0435)
+(0.0030 -0.0075 0.0435)
+(0.0060 -0.0075 0.0435)
+(-0.0060 -0.0045 0.0435)
+(-0.0030 -0.0045 0.0435)
+(0.0000 -0.0045 0.0435)
+(0.0030 -0.0045 0.0435)
+(0.0060 -0.0045 0.0435)
+(-0.0060 -0.0015 0.0435)
+(-0.0030 -0.0015 0.0435)
+(0.0000 -0.0015 0.0435)
+(0.0030 -0.0015 0.0435)
+(0.0060 -0.0015 0.0435)
+(-0.0060 0.0015 0.0435)
+(-0.0030 0.0015 0.0435)
+(0.0000 0.0015 0.0435)
+(0.0030 0.0015 0.0435)
+(0.0060 0.0015 0.0435)
+(-0.0060 0.0045 0.0435)
+(-0.0030 0.0045 0.0435)
+(0.0000 0.0045 0.0435)
+(0.0030 0.0045 0.0435)
+(0.0060 0.0045 0.0435)
+(-0.0060 0.0075 0.0435)
+(-0.0030 0.0075 0.0435)
+(0.0000 0.0075 0.0435)
+(0.0030 0.0075 0.0435)
+(0.0060 0.0075 0.0435)
+(-0.0060 0.0105 0.0435)
+(-0.0030 0.0105 0.0435)
+(0.0000 0.0105 0.0435)
+(0.0030 0.0105 0.0435)
+(0.0060 0.0105 0.0435)
+(-0.0060 0.0135 0.0435)
+(-0.0030 0.0135 0.0435)
+(0.0000 0.0135 0.0435)
+(0.0030 0.0135 0.0435)
+(0.0060 0.0135 0.0435)
+(-0.0060 0.0165 0.0435)
+(-0.0030 0.0165 0.0435)
+(0.0000 0.0165 0.0435)
+(0.0030 0.0165 0.0435)
+(0.0060 0.0165 0.0435)
+(-0.0060 0.0195 0.0435)
+(-0.0030 0.0195 0.0435)
+(0.0000 0.0195 0.0435)
+(0.0030 0.0195 0.0435)
+(0.0060 0.0195 0.0435)
+(-0.0060 0.0225 0.0435)
+(-0.0030 0.0225 0.0435)
+(0.0000 0.0225 0.0435)
+(0.0030 0.0225 0.0435)
+(0.0060 0.0225 0.0435)
+(-0.0060 0.0255 0.0435)
+(-0.0030 0.0255 0.0435)
+(0.0000 0.0255 0.0435)
+(0.0030 0.0255 0.0435)
+(0.0060 0.0255 0.0435)
+(-0.0060 0.0285 0.0435)
+(-0.0030 0.0285 0.0435)
+(0.0000 0.0285 0.0435)
+(0.0030 0.0285 0.0435)
+(0.0060 0.0285 0.0435)
+(-0.0060 0.0315 0.0435)
+(-0.0030 0.0315 0.0435)
+(0.0000 0.0315 0.0435)
+(0.0030 0.0315 0.0435)
+(0.0060 0.0315 0.0435)
+(-0.0060 0.0345 0.0435)
+(-0.0030 0.0345 0.0435)
+(0.0000 0.0345 0.0435)
+(0.0030 0.0345 0.0435)
+(0.0060 0.0345 0.0435)
+(-0.0060 0.0375 0.0435)
+(-0.0030 0.0375 0.0435)
+(0.0000 0.0375 0.0435)
+(0.0030 0.0375 0.0435)
+(0.0060 0.0375 0.0435)
+(-0.0060 0.0405 0.0435)
+(-0.0030 0.0405 0.0435)
+(0.0000 0.0405 0.0435)
+(0.0030 0.0405 0.0435)
+(0.0060 0.0405 0.0435)
+(-0.0060 0.0435 0.0435)
+(-0.0030 0.0435 0.0435)
+(0.0000 0.0435 0.0435)
+(0.0030 0.0435 0.0435)
+(0.0060 0.0435 0.0435)
+(-0.0060 0.0465 0.0435)
+(-0.0030 0.0465 0.0435)
+(0.0000 0.0465 0.0435)
+(0.0030 0.0465 0.0435)
+(0.0060 0.0465 0.0435)
+(-0.0060 0.0495 0.0435)
+(-0.0030 0.0495 0.0435)
+(0.0000 0.0495 0.0435)
+(0.0030 0.0495 0.0435)
+(0.0060 0.0495 0.0435)
+(-0.0060 0.0525 0.0435)
+(-0.0030 0.0525 0.0435)
+(0.0000 0.0525 0.0435)
+(0.0030 0.0525 0.0435)
+(0.0060 0.0525 0.0435)
+(-0.0060 0.0555 0.0435)
+(-0.0030 0.0555 0.0435)
+(0.0000 0.0555 0.0435)
+(0.0030 0.0555 0.0435)
+(0.0060 0.0555 0.0435)
+(-0.0060 0.0585 0.0435)
+(-0.0030 0.0585 0.0435)
+(0.0000 0.0585 0.0435)
+(0.0030 0.0585 0.0435)
+(0.0060 0.0585 0.0435)
+(-0.0060 0.0615 0.0435)
+(-0.0030 0.0615 0.0435)
+(0.0000 0.0615 0.0435)
+(0.0030 0.0615 0.0435)
+(0.0060 0.0615 0.0435)
+(-0.0060 0.0645 0.0435)
+(-0.0030 0.0645 0.0435)
+(0.0000 0.0645 0.0435)
+(0.0030 0.0645 0.0435)
+(0.0060 0.0645 0.0435)
+(-0.0060 0.0675 0.0435)
+(-0.0030 0.0675 0.0435)
+(0.0000 0.0675 0.0435)
+(0.0030 0.0675 0.0435)
+(0.0060 0.0675 0.0435)
+(-0.0060 0.0705 0.0435)
+(-0.0030 0.0705 0.0435)
+(0.0000 0.0705 0.0435)
+(0.0030 0.0705 0.0435)
+(0.0060 0.0705 0.0435)
+(-0.0060 0.0735 0.0435)
+(-0.0030 0.0735 0.0435)
+(0.0000 0.0735 0.0435)
+(0.0030 0.0735 0.0435)
+(0.0060 0.0735 0.0435)
+(-0.0060 -0.0735 0.0465)
+(-0.0030 -0.0735 0.0465)
+(0.0000 -0.0735 0.0465)
+(0.0030 -0.0735 0.0465)
+(0.0060 -0.0735 0.0465)
+(-0.0060 -0.0705 0.0465)
+(-0.0030 -0.0705 0.0465)
+(0.0000 -0.0705 0.0465)
+(0.0030 -0.0705 0.0465)
+(0.0060 -0.0705 0.0465)
+(-0.0060 -0.0675 0.0465)
+(-0.0030 -0.0675 0.0465)
+(0.0000 -0.0675 0.0465)
+(0.0030 -0.0675 0.0465)
+(0.0060 -0.0675 0.0465)
+(-0.0060 -0.0645 0.0465)
+(-0.0030 -0.0645 0.0465)
+(0.0000 -0.0645 0.0465)
+(0.0030 -0.0645 0.0465)
+(0.0060 -0.0645 0.0465)
+(-0.0060 -0.0615 0.0465)
+(-0.0030 -0.0615 0.0465)
+(0.0000 -0.0615 0.0465)
+(0.0030 -0.0615 0.0465)
+(0.0060 -0.0615 0.0465)
+(-0.0060 -0.0585 0.0465)
+(-0.0030 -0.0585 0.0465)
+(0.0000 -0.0585 0.0465)
+(0.0030 -0.0585 0.0465)
+(0.0060 -0.0585 0.0465)
+(-0.0060 -0.0555 0.0465)
+(-0.0030 -0.0555 0.0465)
+(0.0000 -0.0555 0.0465)
+(0.0030 -0.0555 0.0465)
+(0.0060 -0.0555 0.0465)
+(-0.0060 -0.0525 0.0465)
+(-0.0030 -0.0525 0.0465)
+(0.0000 -0.0525 0.0465)
+(0.0030 -0.0525 0.0465)
+(0.0060 -0.0525 0.0465)
+(-0.0060 -0.0495 0.0465)
+(-0.0030 -0.0495 0.0465)
+(0.0000 -0.0495 0.0465)
+(0.0030 -0.0495 0.0465)
+(0.0060 -0.0495 0.0465)
+(-0.0060 -0.0465 0.0465)
+(-0.0030 -0.0465 0.0465)
+(0.0000 -0.0465 0.0465)
+(0.0030 -0.0465 0.0465)
+(0.0060 -0.0465 0.0465)
+(-0.0060 -0.0435 0.0465)
+(-0.0030 -0.0435 0.0465)
+(0.0000 -0.0435 0.0465)
+(0.0030 -0.0435 0.0465)
+(0.0060 -0.0435 0.0465)
+(-0.0060 -0.0405 0.0465)
+(-0.0030 -0.0405 0.0465)
+(0.0000 -0.0405 0.0465)
+(0.0030 -0.0405 0.0465)
+(0.0060 -0.0405 0.0465)
+(-0.0060 -0.0375 0.0465)
+(-0.0030 -0.0375 0.0465)
+(0.0000 -0.0375 0.0465)
+(0.0030 -0.0375 0.0465)
+(0.0060 -0.0375 0.0465)
+(-0.0060 -0.0345 0.0465)
+(-0.0030 -0.0345 0.0465)
+(0.0000 -0.0345 0.0465)
+(0.0030 -0.0345 0.0465)
+(0.0060 -0.0345 0.0465)
+(-0.0060 -0.0315 0.0465)
+(-0.0030 -0.0315 0.0465)
+(0.0000 -0.0315 0.0465)
+(0.0030 -0.0315 0.0465)
+(0.0060 -0.0315 0.0465)
+(-0.0060 -0.0285 0.0465)
+(-0.0030 -0.0285 0.0465)
+(0.0000 -0.0285 0.0465)
+(0.0030 -0.0285 0.0465)
+(0.0060 -0.0285 0.0465)
+(-0.0060 -0.0255 0.0465)
+(-0.0030 -0.0255 0.0465)
+(0.0000 -0.0255 0.0465)
+(0.0030 -0.0255 0.0465)
+(0.0060 -0.0255 0.0465)
+(-0.0060 -0.0225 0.0465)
+(-0.0030 -0.0225 0.0465)
+(0.0000 -0.0225 0.0465)
+(0.0030 -0.0225 0.0465)
+(0.0060 -0.0225 0.0465)
+(-0.0060 -0.0195 0.0465)
+(-0.0030 -0.0195 0.0465)
+(0.0000 -0.0195 0.0465)
+(0.0030 -0.0195 0.0465)
+(0.0060 -0.0195 0.0465)
+(-0.0060 -0.0165 0.0465)
+(-0.0030 -0.0165 0.0465)
+(0.0000 -0.0165 0.0465)
+(0.0030 -0.0165 0.0465)
+(0.0060 -0.0165 0.0465)
+(-0.0060 -0.0135 0.0465)
+(-0.0030 -0.0135 0.0465)
+(0.0000 -0.0135 0.0465)
+(0.0030 -0.0135 0.0465)
+(0.0060 -0.0135 0.0465)
+(-0.0060 -0.0105 0.0465)
+(-0.0030 -0.0105 0.0465)
+(0.0000 -0.0105 0.0465)
+(0.0030 -0.0105 0.0465)
+(0.0060 -0.0105 0.0465)
+(-0.0060 -0.0075 0.0465)
+(-0.0030 -0.0075 0.0465)
+(0.0000 -0.0075 0.0465)
+(0.0030 -0.0075 0.0465)
+(0.0060 -0.0075 0.0465)
+(-0.0060 -0.0045 0.0465)
+(-0.0030 -0.0045 0.0465)
+(0.0000 -0.0045 0.0465)
+(0.0030 -0.0045 0.0465)
+(0.0060 -0.0045 0.0465)
+(-0.0060 -0.0015 0.0465)
+(-0.0030 -0.0015 0.0465)
+(0.0000 -0.0015 0.0465)
+(0.0030 -0.0015 0.0465)
+(0.0060 -0.0015 0.0465)
+(-0.0060 0.0015 0.0465)
+(-0.0030 0.0015 0.0465)
+(0.0000 0.0015 0.0465)
+(0.0030 0.0015 0.0465)
+(0.0060 0.0015 0.0465)
+(-0.0060 0.0045 0.0465)
+(-0.0030 0.0045 0.0465)
+(0.0000 0.0045 0.0465)
+(0.0030 0.0045 0.0465)
+(0.0060 0.0045 0.0465)
+(-0.0060 0.0075 0.0465)
+(-0.0030 0.0075 0.0465)
+(0.0000 0.0075 0.0465)
+(0.0030 0.0075 0.0465)
+(0.0060 0.0075 0.0465)
+(-0.0060 0.0105 0.0465)
+(-0.0030 0.0105 0.0465)
+(0.0000 0.0105 0.0465)
+(0.0030 0.0105 0.0465)
+(0.0060 0.0105 0.0465)
+(-0.0060 0.0135 0.0465)
+(-0.0030 0.0135 0.0465)
+(0.0000 0.0135 0.0465)
+(0.0030 0.0135 0.0465)
+(0.0060 0.0135 0.0465)
+(-0.0060 0.0165 0.0465)
+(-0.0030 0.0165 0.0465)
+(0.0000 0.0165 0.0465)
+(0.0030 0.0165 0.0465)
+(0.0060 0.0165 0.0465)
+(-0.0060 0.0195 0.0465)
+(-0.0030 0.0195 0.0465)
+(0.0000 0.0195 0.0465)
+(0.0030 0.0195 0.0465)
+(0.0060 0.0195 0.0465)
+(-0.0060 0.0225 0.0465)
+(-0.0030 0.0225 0.0465)
+(0.0000 0.0225 0.0465)
+(0.0030 0.0225 0.0465)
+(0.0060 0.0225 0.0465)
+(-0.0060 0.0255 0.0465)
+(-0.0030 0.0255 0.0465)
+(0.0000 0.0255 0.0465)
+(0.0030 0.0255 0.0465)
+(0.0060 0.0255 0.0465)
+(-0.0060 0.0285 0.0465)
+(-0.0030 0.0285 0.0465)
+(0.0000 0.0285 0.0465)
+(0.0030 0.0285 0.0465)
+(0.0060 0.0285 0.0465)
+(-0.0060 0.0315 0.0465)
+(-0.0030 0.0315 0.0465)
+(0.0000 0.0315 0.0465)
+(0.0030 0.0315 0.0465)
+(0.0060 0.0315 0.0465)
+(-0.0060 0.0345 0.0465)
+(-0.0030 0.0345 0.0465)
+(0.0000 0.0345 0.0465)
+(0.0030 0.0345 0.0465)
+(0.0060 0.0345 0.0465)
+(-0.0060 0.0375 0.0465)
+(-0.0030 0.0375 0.0465)
+(0.0000 0.0375 0.0465)
+(0.0030 0.0375 0.0465)
+(0.0060 0.0375 0.0465)
+(-0.0060 0.0405 0.0465)
+(-0.0030 0.0405 0.0465)
+(0.0000 0.0405 0.0465)
+(0.0030 0.0405 0.0465)
+(0.0060 0.0405 0.0465)
+(-0.0060 0.0435 0.0465)
+(-0.0030 0.0435 0.0465)
+(0.0000 0.0435 0.0465)
+(0.0030 0.0435 0.0465)
+(0.0060 0.0435 0.0465)
+(-0.0060 0.0465 0.0465)
+(-0.0030 0.0465 0.0465)
+(0.0000 0.0465 0.0465)
+(0.0030 0.0465 0.0465)
+(0.0060 0.0465 0.0465)
+(-0.0060 0.0495 0.0465)
+(-0.0030 0.0495 0.0465)
+(0.0000 0.0495 0.0465)
+(0.0030 0.0495 0.0465)
+(0.0060 0.0495 0.0465)
+(-0.0060 0.0525 0.0465)
+(-0.0030 0.0525 0.0465)
+(0.0000 0.0525 0.0465)
+(0.0030 0.0525 0.0465)
+(0.0060 0.0525 0.0465)
+(-0.0060 0.0555 0.0465)
+(-0.0030 0.0555 0.0465)
+(0.0000 0.0555 0.0465)
+(0.0030 0.0555 0.0465)
+(0.0060 0.0555 0.0465)
+(-0.0060 0.0585 0.0465)
+(-0.0030 0.0585 0.0465)
+(0.0000 0.0585 0.0465)
+(0.0030 0.0585 0.0465)
+(0.0060 0.0585 0.0465)
+(-0.0060 0.0615 0.0465)
+(-0.0030 0.0615 0.0465)
+(0.0000 0.0615 0.0465)
+(0.0030 0.0615 0.0465)
+(0.0060 0.0615 0.0465)
+(-0.0060 0.0645 0.0465)
+(-0.0030 0.0645 0.0465)
+(0.0000 0.0645 0.0465)
+(0.0030 0.0645 0.0465)
+(0.0060 0.0645 0.0465)
+(-0.0060 0.0675 0.0465)
+(-0.0030 0.0675 0.0465)
+(0.0000 0.0675 0.0465)
+(0.0030 0.0675 0.0465)
+(0.0060 0.0675 0.0465)
+(-0.0060 0.0705 0.0465)
+(-0.0030 0.0705 0.0465)
+(0.0000 0.0705 0.0465)
+(0.0030 0.0705 0.0465)
+(0.0060 0.0705 0.0465)
+(-0.0060 0.0735 0.0465)
+(-0.0030 0.0735 0.0465)
+(0.0000 0.0735 0.0465)
+(0.0030 0.0735 0.0465)
+(0.0060 0.0735 0.0465)
+(-0.0060 -0.0735 0.0495)
+(-0.0030 -0.0735 0.0495)
+(0.0000 -0.0735 0.0495)
+(0.0030 -0.0735 0.0495)
+(0.0060 -0.0735 0.0495)
+(-0.0060 -0.0705 0.0495)
+(-0.0030 -0.0705 0.0495)
+(0.0000 -0.0705 0.0495)
+(0.0030 -0.0705 0.0495)
+(0.0060 -0.0705 0.0495)
+(-0.0060 -0.0675 0.0495)
+(-0.0030 -0.0675 0.0495)
+(0.0000 -0.0675 0.0495)
+(0.0030 -0.0675 0.0495)
+(0.0060 -0.0675 0.0495)
+(-0.0060 -0.0645 0.0495)
+(-0.0030 -0.0645 0.0495)
+(0.0000 -0.0645 0.0495)
+(0.0030 -0.0645 0.0495)
+(0.0060 -0.0645 0.0495)
+(-0.0060 -0.0615 0.0495)
+(-0.0030 -0.0615 0.0495)
+(0.0000 -0.0615 0.0495)
+(0.0030 -0.0615 0.0495)
+(0.0060 -0.0615 0.0495)
+(-0.0060 -0.0585 0.0495)
+(-0.0030 -0.0585 0.0495)
+(0.0000 -0.0585 0.0495)
+(0.0030 -0.0585 0.0495)
+(0.0060 -0.0585 0.0495)
+(-0.0060 -0.0555 0.0495)
+(-0.0030 -0.0555 0.0495)
+(0.0000 -0.0555 0.0495)
+(0.0030 -0.0555 0.0495)
+(0.0060 -0.0555 0.0495)
+(-0.0060 -0.0525 0.0495)
+(-0.0030 -0.0525 0.0495)
+(0.0000 -0.0525 0.0495)
+(0.0030 -0.0525 0.0495)
+(0.0060 -0.0525 0.0495)
+(-0.0060 -0.0495 0.0495)
+(-0.0030 -0.0495 0.0495)
+(0.0000 -0.0495 0.0495)
+(0.0030 -0.0495 0.0495)
+(0.0060 -0.0495 0.0495)
+(-0.0060 -0.0465 0.0495)
+(-0.0030 -0.0465 0.0495)
+(0.0000 -0.0465 0.0495)
+(0.0030 -0.0465 0.0495)
+(0.0060 -0.0465 0.0495)
+(-0.0060 -0.0435 0.0495)
+(-0.0030 -0.0435 0.0495)
+(0.0000 -0.0435 0.0495)
+(0.0030 -0.0435 0.0495)
+(0.0060 -0.0435 0.0495)
+(-0.0060 -0.0405 0.0495)
+(-0.0030 -0.0405 0.0495)
+(0.0000 -0.0405 0.0495)
+(0.0030 -0.0405 0.0495)
+(0.0060 -0.0405 0.0495)
+(-0.0060 -0.0375 0.0495)
+(-0.0030 -0.0375 0.0495)
+(0.0000 -0.0375 0.0495)
+(0.0030 -0.0375 0.0495)
+(0.0060 -0.0375 0.0495)
+(-0.0060 -0.0345 0.0495)
+(-0.0030 -0.0345 0.0495)
+(0.0000 -0.0345 0.0495)
+(0.0030 -0.0345 0.0495)
+(0.0060 -0.0345 0.0495)
+(-0.0060 -0.0315 0.0495)
+(-0.0030 -0.0315 0.0495)
+(0.0000 -0.0315 0.0495)
+(0.0030 -0.0315 0.0495)
+(0.0060 -0.0315 0.0495)
+(-0.0060 -0.0285 0.0495)
+(-0.0030 -0.0285 0.0495)
+(0.0000 -0.0285 0.0495)
+(0.0030 -0.0285 0.0495)
+(0.0060 -0.0285 0.0495)
+(-0.0060 -0.0255 0.0495)
+(-0.0030 -0.0255 0.0495)
+(0.0000 -0.0255 0.0495)
+(0.0030 -0.0255 0.0495)
+(0.0060 -0.0255 0.0495)
+(-0.0060 -0.0225 0.0495)
+(-0.0030 -0.0225 0.0495)
+(0.0000 -0.0225 0.0495)
+(0.0030 -0.0225 0.0495)
+(0.0060 -0.0225 0.0495)
+(-0.0060 -0.0195 0.0495)
+(-0.0030 -0.0195 0.0495)
+(0.0000 -0.0195 0.0495)
+(0.0030 -0.0195 0.0495)
+(0.0060 -0.0195 0.0495)
+(-0.0060 -0.0165 0.0495)
+(-0.0030 -0.0165 0.0495)
+(0.0000 -0.0165 0.0495)
+(0.0030 -0.0165 0.0495)
+(0.0060 -0.0165 0.0495)
+(-0.0060 -0.0135 0.0495)
+(-0.0030 -0.0135 0.0495)
+(0.0000 -0.0135 0.0495)
+(0.0030 -0.0135 0.0495)
+(0.0060 -0.0135 0.0495)
+(-0.0060 -0.0105 0.0495)
+(-0.0030 -0.0105 0.0495)
+(0.0000 -0.0105 0.0495)
+(0.0030 -0.0105 0.0495)
+(0.0060 -0.0105 0.0495)
+(-0.0060 -0.0075 0.0495)
+(-0.0030 -0.0075 0.0495)
+(0.0000 -0.0075 0.0495)
+(0.0030 -0.0075 0.0495)
+(0.0060 -0.0075 0.0495)
+(-0.0060 -0.0045 0.0495)
+(-0.0030 -0.0045 0.0495)
+(0.0000 -0.0045 0.0495)
+(0.0030 -0.0045 0.0495)
+(0.0060 -0.0045 0.0495)
+(-0.0060 -0.0015 0.0495)
+(-0.0030 -0.0015 0.0495)
+(0.0000 -0.0015 0.0495)
+(0.0030 -0.0015 0.0495)
+(0.0060 -0.0015 0.0495)
+(-0.0060 0.0015 0.0495)
+(-0.0030 0.0015 0.0495)
+(0.0000 0.0015 0.0495)
+(0.0030 0.0015 0.0495)
+(0.0060 0.0015 0.0495)
+(-0.0060 0.0045 0.0495)
+(-0.0030 0.0045 0.0495)
+(0.0000 0.0045 0.0495)
+(0.0030 0.0045 0.0495)
+(0.0060 0.0045 0.0495)
+(-0.0060 0.0075 0.0495)
+(-0.0030 0.0075 0.0495)
+(0.0000 0.0075 0.0495)
+(0.0030 0.0075 0.0495)
+(0.0060 0.0075 0.0495)
+(-0.0060 0.0105 0.0495)
+(-0.0030 0.0105 0.0495)
+(0.0000 0.0105 0.0495)
+(0.0030 0.0105 0.0495)
+(0.0060 0.0105 0.0495)
+(-0.0060 0.0135 0.0495)
+(-0.0030 0.0135 0.0495)
+(0.0000 0.0135 0.0495)
+(0.0030 0.0135 0.0495)
+(0.0060 0.0135 0.0495)
+(-0.0060 0.0165 0.0495)
+(-0.0030 0.0165 0.0495)
+(0.0000 0.0165 0.0495)
+(0.0030 0.0165 0.0495)
+(0.0060 0.0165 0.0495)
+(-0.0060 0.0195 0.0495)
+(-0.0030 0.0195 0.0495)
+(0.0000 0.0195 0.0495)
+(0.0030 0.0195 0.0495)
+(0.0060 0.0195 0.0495)
+(-0.0060 0.0225 0.0495)
+(-0.0030 0.0225 0.0495)
+(0.0000 0.0225 0.0495)
+(0.0030 0.0225 0.0495)
+(0.0060 0.0225 0.0495)
+(-0.0060 0.0255 0.0495)
+(-0.0030 0.0255 0.0495)
+(0.0000 0.0255 0.0495)
+(0.0030 0.0255 0.0495)
+(0.0060 0.0255 0.0495)
+(-0.0060 0.0285 0.0495)
+(-0.0030 0.0285 0.0495)
+(0.0000 0.0285 0.0495)
+(0.0030 0.0285 0.0495)
+(0.0060 0.0285 0.0495)
+(-0.0060 0.0315 0.0495)
+(-0.0030 0.0315 0.0495)
+(0.0000 0.0315 0.0495)
+(0.0030 0.0315 0.0495)
+(0.0060 0.0315 0.0495)
+(-0.0060 0.0345 0.0495)
+(-0.0030 0.0345 0.0495)
+(0.0000 0.0345 0.0495)
+(0.0030 0.0345 0.0495)
+(0.0060 0.0345 0.0495)
+(-0.0060 0.0375 0.0495)
+(-0.0030 0.0375 0.0495)
+(0.0000 0.0375 0.0495)
+(0.0030 0.0375 0.0495)
+(0.0060 0.0375 0.0495)
+(-0.0060 0.0405 0.0495)
+(-0.0030 0.0405 0.0495)
+(0.0000 0.0405 0.0495)
+(0.0030 0.0405 0.0495)
+(0.0060 0.0405 0.0495)
+(-0.0060 0.0435 0.0495)
+(-0.0030 0.0435 0.0495)
+(0.0000 0.0435 0.0495)
+(0.0030 0.0435 0.0495)
+(0.0060 0.0435 0.0495)
+(-0.0060 0.0465 0.0495)
+(-0.0030 0.0465 0.0495)
+(0.0000 0.0465 0.0495)
+(0.0030 0.0465 0.0495)
+(0.0060 0.0465 0.0495)
+(-0.0060 0.0495 0.0495)
+(-0.0030 0.0495 0.0495)
+(0.0000 0.0495 0.0495)
+(0.0030 0.0495 0.0495)
+(0.0060 0.0495 0.0495)
+(-0.0060 0.0525 0.0495)
+(-0.0030 0.0525 0.0495)
+(0.0000 0.0525 0.0495)
+(0.0030 0.0525 0.0495)
+(0.0060 0.0525 0.0495)
+(-0.0060 0.0555 0.0495)
+(-0.0030 0.0555 0.0495)
+(0.0000 0.0555 0.0495)
+(0.0030 0.0555 0.0495)
+(0.0060 0.0555 0.0495)
+(-0.0060 0.0585 0.0495)
+(-0.0030 0.0585 0.0495)
+(0.0000 0.0585 0.0495)
+(0.0030 0.0585 0.0495)
+(0.0060 0.0585 0.0495)
+(-0.0060 0.0615 0.0495)
+(-0.0030 0.0615 0.0495)
+(0.0000 0.0615 0.0495)
+(0.0030 0.0615 0.0495)
+(0.0060 0.0615 0.0495)
+(-0.0060 0.0645 0.0495)
+(-0.0030 0.0645 0.0495)
+(0.0000 0.0645 0.0495)
+(0.0030 0.0645 0.0495)
+(0.0060 0.0645 0.0495)
+(-0.0060 0.0675 0.0495)
+(-0.0030 0.0675 0.0495)
+(0.0000 0.0675 0.0495)
+(0.0030 0.0675 0.0495)
+(0.0060 0.0675 0.0495)
+(-0.0060 0.0705 0.0495)
+(-0.0030 0.0705 0.0495)
+(0.0000 0.0705 0.0495)
+(0.0030 0.0705 0.0495)
+(0.0060 0.0705 0.0495)
+(-0.0060 0.0735 0.0495)
+(-0.0030 0.0735 0.0495)
+(0.0000 0.0735 0.0495)
+(0.0030 0.0735 0.0495)
+(0.0060 0.0735 0.0495)
+(-0.0060 -0.0735 0.0525)
+(-0.0030 -0.0735 0.0525)
+(0.0000 -0.0735 0.0525)
+(0.0030 -0.0735 0.0525)
+(0.0060 -0.0735 0.0525)
+(-0.0060 -0.0705 0.0525)
+(-0.0030 -0.0705 0.0525)
+(0.0000 -0.0705 0.0525)
+(0.0030 -0.0705 0.0525)
+(0.0060 -0.0705 0.0525)
+(-0.0060 -0.0675 0.0525)
+(-0.0030 -0.0675 0.0525)
+(0.0000 -0.0675 0.0525)
+(0.0030 -0.0675 0.0525)
+(0.0060 -0.0675 0.0525)
+(-0.0060 -0.0645 0.0525)
+(-0.0030 -0.0645 0.0525)
+(0.0000 -0.0645 0.0525)
+(0.0030 -0.0645 0.0525)
+(0.0060 -0.0645 0.0525)
+(-0.0060 -0.0615 0.0525)
+(-0.0030 -0.0615 0.0525)
+(0.0000 -0.0615 0.0525)
+(0.0030 -0.0615 0.0525)
+(0.0060 -0.0615 0.0525)
+(-0.0060 -0.0585 0.0525)
+(-0.0030 -0.0585 0.0525)
+(0.0000 -0.0585 0.0525)
+(0.0030 -0.0585 0.0525)
+(0.0060 -0.0585 0.0525)
+(-0.0060 -0.0555 0.0525)
+(-0.0030 -0.0555 0.0525)
+(0.0000 -0.0555 0.0525)
+(0.0030 -0.0555 0.0525)
+(0.0060 -0.0555 0.0525)
+(-0.0060 -0.0525 0.0525)
+(-0.0030 -0.0525 0.0525)
+(0.0000 -0.0525 0.0525)
+(0.0030 -0.0525 0.0525)
+(0.0060 -0.0525 0.0525)
+(-0.0060 -0.0495 0.0525)
+(-0.0030 -0.0495 0.0525)
+(0.0000 -0.0495 0.0525)
+(0.0030 -0.0495 0.0525)
+(0.0060 -0.0495 0.0525)
+(-0.0060 -0.0465 0.0525)
+(-0.0030 -0.0465 0.0525)
+(0.0000 -0.0465 0.0525)
+(0.0030 -0.0465 0.0525)
+(0.0060 -0.0465 0.0525)
+(-0.0060 -0.0435 0.0525)
+(-0.0030 -0.0435 0.0525)
+(0.0000 -0.0435 0.0525)
+(0.0030 -0.0435 0.0525)
+(0.0060 -0.0435 0.0525)
+(-0.0060 -0.0405 0.0525)
+(-0.0030 -0.0405 0.0525)
+(0.0000 -0.0405 0.0525)
+(0.0030 -0.0405 0.0525)
+(0.0060 -0.0405 0.0525)
+(-0.0060 -0.0375 0.0525)
+(-0.0030 -0.0375 0.0525)
+(0.0000 -0.0375 0.0525)
+(0.0030 -0.0375 0.0525)
+(0.0060 -0.0375 0.0525)
+(-0.0060 -0.0345 0.0525)
+(-0.0030 -0.0345 0.0525)
+(0.0000 -0.0345 0.0525)
+(0.0030 -0.0345 0.0525)
+(0.0060 -0.0345 0.0525)
+(-0.0060 -0.0315 0.0525)
+(-0.0030 -0.0315 0.0525)
+(0.0000 -0.0315 0.0525)
+(0.0030 -0.0315 0.0525)
+(0.0060 -0.0315 0.0525)
+(-0.0060 -0.0285 0.0525)
+(-0.0030 -0.0285 0.0525)
+(0.0000 -0.0285 0.0525)
+(0.0030 -0.0285 0.0525)
+(0.0060 -0.0285 0.0525)
+(-0.0060 -0.0255 0.0525)
+(-0.0030 -0.0255 0.0525)
+(0.0000 -0.0255 0.0525)
+(0.0030 -0.0255 0.0525)
+(0.0060 -0.0255 0.0525)
+(-0.0060 -0.0225 0.0525)
+(-0.0030 -0.0225 0.0525)
+(0.0000 -0.0225 0.0525)
+(0.0030 -0.0225 0.0525)
+(0.0060 -0.0225 0.0525)
+(-0.0060 -0.0195 0.0525)
+(-0.0030 -0.0195 0.0525)
+(0.0000 -0.0195 0.0525)
+(0.0030 -0.0195 0.0525)
+(0.0060 -0.0195 0.0525)
+(-0.0060 -0.0165 0.0525)
+(-0.0030 -0.0165 0.0525)
+(0.0000 -0.0165 0.0525)
+(0.0030 -0.0165 0.0525)
+(0.0060 -0.0165 0.0525)
+(-0.0060 -0.0135 0.0525)
+(-0.0030 -0.0135 0.0525)
+(0.0000 -0.0135 0.0525)
+(0.0030 -0.0135 0.0525)
+(0.0060 -0.0135 0.0525)
+(-0.0060 -0.0105 0.0525)
+(-0.0030 -0.0105 0.0525)
+(0.0000 -0.0105 0.0525)
+(0.0030 -0.0105 0.0525)
+(0.0060 -0.0105 0.0525)
+(-0.0060 -0.0075 0.0525)
+(-0.0030 -0.0075 0.0525)
+(0.0000 -0.0075 0.0525)
+(0.0030 -0.0075 0.0525)
+(0.0060 -0.0075 0.0525)
+(-0.0060 -0.0045 0.0525)
+(-0.0030 -0.0045 0.0525)
+(0.0000 -0.0045 0.0525)
+(0.0030 -0.0045 0.0525)
+(0.0060 -0.0045 0.0525)
+(-0.0060 -0.0015 0.0525)
+(-0.0030 -0.0015 0.0525)
+(0.0000 -0.0015 0.0525)
+(0.0030 -0.0015 0.0525)
+(0.0060 -0.0015 0.0525)
+(-0.0060 0.0015 0.0525)
+(-0.0030 0.0015 0.0525)
+(0.0000 0.0015 0.0525)
+(0.0030 0.0015 0.0525)
+(0.0060 0.0015 0.0525)
+(-0.0060 0.0045 0.0525)
+(-0.0030 0.0045 0.0525)
+(0.0000 0.0045 0.0525)
+(0.0030 0.0045 0.0525)
+(0.0060 0.0045 0.0525)
+(-0.0060 0.0075 0.0525)
+(-0.0030 0.0075 0.0525)
+(0.0000 0.0075 0.0525)
+(0.0030 0.0075 0.0525)
+(0.0060 0.0075 0.0525)
+(-0.0060 0.0105 0.0525)
+(-0.0030 0.0105 0.0525)
+(0.0000 0.0105 0.0525)
+(0.0030 0.0105 0.0525)
+(0.0060 0.0105 0.0525)
+(-0.0060 0.0135 0.0525)
+(-0.0030 0.0135 0.0525)
+(0.0000 0.0135 0.0525)
+(0.0030 0.0135 0.0525)
+(0.0060 0.0135 0.0525)
+(-0.0060 0.0165 0.0525)
+(-0.0030 0.0165 0.0525)
+(0.0000 0.0165 0.0525)
+(0.0030 0.0165 0.0525)
+(0.0060 0.0165 0.0525)
+(-0.0060 0.0195 0.0525)
+(-0.0030 0.0195 0.0525)
+(0.0000 0.0195 0.0525)
+(0.0030 0.0195 0.0525)
+(0.0060 0.0195 0.0525)
+(-0.0060 0.0225 0.0525)
+(-0.0030 0.0225 0.0525)
+(0.0000 0.0225 0.0525)
+(0.0030 0.0225 0.0525)
+(0.0060 0.0225 0.0525)
+(-0.0060 0.0255 0.0525)
+(-0.0030 0.0255 0.0525)
+(0.0000 0.0255 0.0525)
+(0.0030 0.0255 0.0525)
+(0.0060 0.0255 0.0525)
+(-0.0060 0.0285 0.0525)
+(-0.0030 0.0285 0.0525)
+(0.0000 0.0285 0.0525)
+(0.0030 0.0285 0.0525)
+(0.0060 0.0285 0.0525)
+(-0.0060 0.0315 0.0525)
+(-0.0030 0.0315 0.0525)
+(0.0000 0.0315 0.0525)
+(0.0030 0.0315 0.0525)
+(0.0060 0.0315 0.0525)
+(-0.0060 0.0345 0.0525)
+(-0.0030 0.0345 0.0525)
+(0.0000 0.0345 0.0525)
+(0.0030 0.0345 0.0525)
+(0.0060 0.0345 0.0525)
+(-0.0060 0.0375 0.0525)
+(-0.0030 0.0375 0.0525)
+(0.0000 0.0375 0.0525)
+(0.0030 0.0375 0.0525)
+(0.0060 0.0375 0.0525)
+(-0.0060 0.0405 0.0525)
+(-0.0030 0.0405 0.0525)
+(0.0000 0.0405 0.0525)
+(0.0030 0.0405 0.0525)
+(0.0060 0.0405 0.0525)
+(-0.0060 0.0435 0.0525)
+(-0.0030 0.0435 0.0525)
+(0.0000 0.0435 0.0525)
+(0.0030 0.0435 0.0525)
+(0.0060 0.0435 0.0525)
+(-0.0060 0.0465 0.0525)
+(-0.0030 0.0465 0.0525)
+(0.0000 0.0465 0.0525)
+(0.0030 0.0465 0.0525)
+(0.0060 0.0465 0.0525)
+(-0.0060 0.0495 0.0525)
+(-0.0030 0.0495 0.0525)
+(0.0000 0.0495 0.0525)
+(0.0030 0.0495 0.0525)
+(0.0060 0.0495 0.0525)
+(-0.0060 0.0525 0.0525)
+(-0.0030 0.0525 0.0525)
+(0.0000 0.0525 0.0525)
+(0.0030 0.0525 0.0525)
+(0.0060 0.0525 0.0525)
+(-0.0060 0.0555 0.0525)
+(-0.0030 0.0555 0.0525)
+(0.0000 0.0555 0.0525)
+(0.0030 0.0555 0.0525)
+(0.0060 0.0555 0.0525)
+(-0.0060 0.0585 0.0525)
+(-0.0030 0.0585 0.0525)
+(0.0000 0.0585 0.0525)
+(0.0030 0.0585 0.0525)
+(0.0060 0.0585 0.0525)
+(-0.0060 0.0615 0.0525)
+(-0.0030 0.0615 0.0525)
+(0.0000 0.0615 0.0525)
+(0.0030 0.0615 0.0525)
+(0.0060 0.0615 0.0525)
+(-0.0060 0.0645 0.0525)
+(-0.0030 0.0645 0.0525)
+(0.0000 0.0645 0.0525)
+(0.0030 0.0645 0.0525)
+(0.0060 0.0645 0.0525)
+(-0.0060 0.0675 0.0525)
+(-0.0030 0.0675 0.0525)
+(0.0000 0.0675 0.0525)
+(0.0030 0.0675 0.0525)
+(0.0060 0.0675 0.0525)
+(-0.0060 0.0705 0.0525)
+(-0.0030 0.0705 0.0525)
+(0.0000 0.0705 0.0525)
+(0.0030 0.0705 0.0525)
+(0.0060 0.0705 0.0525)
+(-0.0060 0.0735 0.0525)
+(-0.0030 0.0735 0.0525)
+(0.0000 0.0735 0.0525)
+(0.0030 0.0735 0.0525)
+(0.0060 0.0735 0.0525)
+(-0.0060 -0.0735 0.0555)
+(-0.0030 -0.0735 0.0555)
+(0.0000 -0.0735 0.0555)
+(0.0030 -0.0735 0.0555)
+(0.0060 -0.0735 0.0555)
+(-0.0060 -0.0705 0.0555)
+(-0.0030 -0.0705 0.0555)
+(0.0000 -0.0705 0.0555)
+(0.0030 -0.0705 0.0555)
+(0.0060 -0.0705 0.0555)
+(-0.0060 -0.0675 0.0555)
+(-0.0030 -0.0675 0.0555)
+(0.0000 -0.0675 0.0555)
+(0.0030 -0.0675 0.0555)
+(0.0060 -0.0675 0.0555)
+(-0.0060 -0.0645 0.0555)
+(-0.0030 -0.0645 0.0555)
+(0.0000 -0.0645 0.0555)
+(0.0030 -0.0645 0.0555)
+(0.0060 -0.0645 0.0555)
+(-0.0060 -0.0615 0.0555)
+(-0.0030 -0.0615 0.0555)
+(0.0000 -0.0615 0.0555)
+(0.0030 -0.0615 0.0555)
+(0.0060 -0.0615 0.0555)
+(-0.0060 -0.0585 0.0555)
+(-0.0030 -0.0585 0.0555)
+(0.0000 -0.0585 0.0555)
+(0.0030 -0.0585 0.0555)
+(0.0060 -0.0585 0.0555)
+(-0.0060 -0.0555 0.0555)
+(-0.0030 -0.0555 0.0555)
+(0.0000 -0.0555 0.0555)
+(0.0030 -0.0555 0.0555)
+(0.0060 -0.0555 0.0555)
+(-0.0060 -0.0525 0.0555)
+(-0.0030 -0.0525 0.0555)
+(0.0000 -0.0525 0.0555)
+(0.0030 -0.0525 0.0555)
+(0.0060 -0.0525 0.0555)
+(-0.0060 -0.0495 0.0555)
+(-0.0030 -0.0495 0.0555)
+(0.0000 -0.0495 0.0555)
+(0.0030 -0.0495 0.0555)
+(0.0060 -0.0495 0.0555)
+(-0.0060 -0.0465 0.0555)
+(-0.0030 -0.0465 0.0555)
+(0.0000 -0.0465 0.0555)
+(0.0030 -0.0465 0.0555)
+(0.0060 -0.0465 0.0555)
+(-0.0060 -0.0435 0.0555)
+(-0.0030 -0.0435 0.0555)
+(0.0000 -0.0435 0.0555)
+(0.0030 -0.0435 0.0555)
+(0.0060 -0.0435 0.0555)
+(-0.0060 -0.0405 0.0555)
+(-0.0030 -0.0405 0.0555)
+(0.0000 -0.0405 0.0555)
+(0.0030 -0.0405 0.0555)
+(0.0060 -0.0405 0.0555)
+(-0.0060 -0.0375 0.0555)
+(-0.0030 -0.0375 0.0555)
+(0.0000 -0.0375 0.0555)
+(0.0030 -0.0375 0.0555)
+(0.0060 -0.0375 0.0555)
+(-0.0060 -0.0345 0.0555)
+(-0.0030 -0.0345 0.0555)
+(0.0000 -0.0345 0.0555)
+(0.0030 -0.0345 0.0555)
+(0.0060 -0.0345 0.0555)
+(-0.0060 -0.0315 0.0555)
+(-0.0030 -0.0315 0.0555)
+(0.0000 -0.0315 0.0555)
+(0.0030 -0.0315 0.0555)
+(0.0060 -0.0315 0.0555)
+(-0.0060 -0.0285 0.0555)
+(-0.0030 -0.0285 0.0555)
+(0.0000 -0.0285 0.0555)
+(0.0030 -0.0285 0.0555)
+(0.0060 -0.0285 0.0555)
+(-0.0060 -0.0255 0.0555)
+(-0.0030 -0.0255 0.0555)
+(0.0000 -0.0255 0.0555)
+(0.0030 -0.0255 0.0555)
+(0.0060 -0.0255 0.0555)
+(-0.0060 -0.0225 0.0555)
+(-0.0030 -0.0225 0.0555)
+(0.0000 -0.0225 0.0555)
+(0.0030 -0.0225 0.0555)
+(0.0060 -0.0225 0.0555)
+(-0.0060 -0.0195 0.0555)
+(-0.0030 -0.0195 0.0555)
+(0.0000 -0.0195 0.0555)
+(0.0030 -0.0195 0.0555)
+(0.0060 -0.0195 0.0555)
+(-0.0060 -0.0165 0.0555)
+(-0.0030 -0.0165 0.0555)
+(0.0000 -0.0165 0.0555)
+(0.0030 -0.0165 0.0555)
+(0.0060 -0.0165 0.0555)
+(-0.0060 -0.0135 0.0555)
+(-0.0030 -0.0135 0.0555)
+(0.0000 -0.0135 0.0555)
+(0.0030 -0.0135 0.0555)
+(0.0060 -0.0135 0.0555)
+(-0.0060 -0.0105 0.0555)
+(-0.0030 -0.0105 0.0555)
+(0.0000 -0.0105 0.0555)
+(0.0030 -0.0105 0.0555)
+(0.0060 -0.0105 0.0555)
+(-0.0060 -0.0075 0.0555)
+(-0.0030 -0.0075 0.0555)
+(0.0000 -0.0075 0.0555)
+(0.0030 -0.0075 0.0555)
+(0.0060 -0.0075 0.0555)
+(-0.0060 -0.0045 0.0555)
+(-0.0030 -0.0045 0.0555)
+(0.0000 -0.0045 0.0555)
+(0.0030 -0.0045 0.0555)
+(0.0060 -0.0045 0.0555)
+(-0.0060 -0.0015 0.0555)
+(-0.0030 -0.0015 0.0555)
+(0.0000 -0.0015 0.0555)
+(0.0030 -0.0015 0.0555)
+(0.0060 -0.0015 0.0555)
+(-0.0060 0.0015 0.0555)
+(-0.0030 0.0015 0.0555)
+(0.0000 0.0015 0.0555)
+(0.0030 0.0015 0.0555)
+(0.0060 0.0015 0.0555)
+(-0.0060 0.0045 0.0555)
+(-0.0030 0.0045 0.0555)
+(0.0000 0.0045 0.0555)
+(0.0030 0.0045 0.0555)
+(0.0060 0.0045 0.0555)
+(-0.0060 0.0075 0.0555)
+(-0.0030 0.0075 0.0555)
+(0.0000 0.0075 0.0555)
+(0.0030 0.0075 0.0555)
+(0.0060 0.0075 0.0555)
+(-0.0060 0.0105 0.0555)
+(-0.0030 0.0105 0.0555)
+(0.0000 0.0105 0.0555)
+(0.0030 0.0105 0.0555)
+(0.0060 0.0105 0.0555)
+(-0.0060 0.0135 0.0555)
+(-0.0030 0.0135 0.0555)
+(0.0000 0.0135 0.0555)
+(0.0030 0.0135 0.0555)
+(0.0060 0.0135 0.0555)
+(-0.0060 0.0165 0.0555)
+(-0.0030 0.0165 0.0555)
+(0.0000 0.0165 0.0555)
+(0.0030 0.0165 0.0555)
+(0.0060 0.0165 0.0555)
+(-0.0060 0.0195 0.0555)
+(-0.0030 0.0195 0.0555)
+(0.0000 0.0195 0.0555)
+(0.0030 0.0195 0.0555)
+(0.0060 0.0195 0.0555)
+(-0.0060 0.0225 0.0555)
+(-0.0030 0.0225 0.0555)
+(0.0000 0.0225 0.0555)
+(0.0030 0.0225 0.0555)
+(0.0060 0.0225 0.0555)
+(-0.0060 0.0255 0.0555)
+(-0.0030 0.0255 0.0555)
+(0.0000 0.0255 0.0555)
+(0.0030 0.0255 0.0555)
+(0.0060 0.0255 0.0555)
+(-0.0060 0.0285 0.0555)
+(-0.0030 0.0285 0.0555)
+(0.0000 0.0285 0.0555)
+(0.0030 0.0285 0.0555)
+(0.0060 0.0285 0.0555)
+(-0.0060 0.0315 0.0555)
+(-0.0030 0.0315 0.0555)
+(0.0000 0.0315 0.0555)
+(0.0030 0.0315 0.0555)
+(0.0060 0.0315 0.0555)
+(-0.0060 0.0345 0.0555)
+(-0.0030 0.0345 0.0555)
+(0.0000 0.0345 0.0555)
+(0.0030 0.0345 0.0555)
+(0.0060 0.0345 0.0555)
+(-0.0060 0.0375 0.0555)
+(-0.0030 0.0375 0.0555)
+(0.0000 0.0375 0.0555)
+(0.0030 0.0375 0.0555)
+(0.0060 0.0375 0.0555)
+(-0.0060 0.0405 0.0555)
+(-0.0030 0.0405 0.0555)
+(0.0000 0.0405 0.0555)
+(0.0030 0.0405 0.0555)
+(0.0060 0.0405 0.0555)
+(-0.0060 0.0435 0.0555)
+(-0.0030 0.0435 0.0555)
+(0.0000 0.0435 0.0555)
+(0.0030 0.0435 0.0555)
+(0.0060 0.0435 0.0555)
+(-0.0060 0.0465 0.0555)
+(-0.0030 0.0465 0.0555)
+(0.0000 0.0465 0.0555)
+(0.0030 0.0465 0.0555)
+(0.0060 0.0465 0.0555)
+(-0.0060 0.0495 0.0555)
+(-0.0030 0.0495 0.0555)
+(0.0000 0.0495 0.0555)
+(0.0030 0.0495 0.0555)
+(0.0060 0.0495 0.0555)
+(-0.0060 0.0525 0.0555)
+(-0.0030 0.0525 0.0555)
+(0.0000 0.0525 0.0555)
+(0.0030 0.0525 0.0555)
+(0.0060 0.0525 0.0555)
+(-0.0060 0.0555 0.0555)
+(-0.0030 0.0555 0.0555)
+(0.0000 0.0555 0.0555)
+(0.0030 0.0555 0.0555)
+(0.0060 0.0555 0.0555)
+(-0.0060 0.0585 0.0555)
+(-0.0030 0.0585 0.0555)
+(0.0000 0.0585 0.0555)
+(0.0030 0.0585 0.0555)
+(0.0060 0.0585 0.0555)
+(-0.0060 0.0615 0.0555)
+(-0.0030 0.0615 0.0555)
+(0.0000 0.0615 0.0555)
+(0.0030 0.0615 0.0555)
+(0.0060 0.0615 0.0555)
+(-0.0060 0.0645 0.0555)
+(-0.0030 0.0645 0.0555)
+(0.0000 0.0645 0.0555)
+(0.0030 0.0645 0.0555)
+(0.0060 0.0645 0.0555)
+(-0.0060 0.0675 0.0555)
+(-0.0030 0.0675 0.0555)
+(0.0000 0.0675 0.0555)
+(0.0030 0.0675 0.0555)
+(0.0060 0.0675 0.0555)
+(-0.0060 0.0705 0.0555)
+(-0.0030 0.0705 0.0555)
+(0.0000 0.0705 0.0555)
+(0.0030 0.0705 0.0555)
+(0.0060 0.0705 0.0555)
+(-0.0060 0.0735 0.0555)
+(-0.0030 0.0735 0.0555)
+(0.0000 0.0735 0.0555)
+(0.0030 0.0735 0.0555)
+(0.0060 0.0735 0.0555)
+(-0.0060 -0.0735 0.0585)
+(-0.0030 -0.0735 0.0585)
+(0.0000 -0.0735 0.0585)
+(0.0030 -0.0735 0.0585)
+(0.0060 -0.0735 0.0585)
+(-0.0060 -0.0705 0.0585)
+(-0.0030 -0.0705 0.0585)
+(0.0000 -0.0705 0.0585)
+(0.0030 -0.0705 0.0585)
+(0.0060 -0.0705 0.0585)
+(-0.0060 -0.0675 0.0585)
+(-0.0030 -0.0675 0.0585)
+(0.0000 -0.0675 0.0585)
+(0.0030 -0.0675 0.0585)
+(0.0060 -0.0675 0.0585)
+(-0.0060 -0.0645 0.0585)
+(-0.0030 -0.0645 0.0585)
+(0.0000 -0.0645 0.0585)
+(0.0030 -0.0645 0.0585)
+(0.0060 -0.0645 0.0585)
+(-0.0060 -0.0615 0.0585)
+(-0.0030 -0.0615 0.0585)
+(0.0000 -0.0615 0.0585)
+(0.0030 -0.0615 0.0585)
+(0.0060 -0.0615 0.0585)
+(-0.0060 -0.0585 0.0585)
+(-0.0030 -0.0585 0.0585)
+(0.0000 -0.0585 0.0585)
+(0.0030 -0.0585 0.0585)
+(0.0060 -0.0585 0.0585)
+(-0.0060 -0.0555 0.0585)
+(-0.0030 -0.0555 0.0585)
+(0.0000 -0.0555 0.0585)
+(0.0030 -0.0555 0.0585)
+(0.0060 -0.0555 0.0585)
+(-0.0060 -0.0525 0.0585)
+(-0.0030 -0.0525 0.0585)
+(0.0000 -0.0525 0.0585)
+(0.0030 -0.0525 0.0585)
+(0.0060 -0.0525 0.0585)
+(-0.0060 -0.0495 0.0585)
+(-0.0030 -0.0495 0.0585)
+(0.0000 -0.0495 0.0585)
+(0.0030 -0.0495 0.0585)
+(0.0060 -0.0495 0.0585)
+(-0.0060 -0.0465 0.0585)
+(-0.0030 -0.0465 0.0585)
+(0.0000 -0.0465 0.0585)
+(0.0030 -0.0465 0.0585)
+(0.0060 -0.0465 0.0585)
+(-0.0060 -0.0435 0.0585)
+(-0.0030 -0.0435 0.0585)
+(0.0000 -0.0435 0.0585)
+(0.0030 -0.0435 0.0585)
+(0.0060 -0.0435 0.0585)
+(-0.0060 -0.0405 0.0585)
+(-0.0030 -0.0405 0.0585)
+(0.0000 -0.0405 0.0585)
+(0.0030 -0.0405 0.0585)
+(0.0060 -0.0405 0.0585)
+(-0.0060 -0.0375 0.0585)
+(-0.0030 -0.0375 0.0585)
+(0.0000 -0.0375 0.0585)
+(0.0030 -0.0375 0.0585)
+(0.0060 -0.0375 0.0585)
+(-0.0060 -0.0345 0.0585)
+(-0.0030 -0.0345 0.0585)
+(0.0000 -0.0345 0.0585)
+(0.0030 -0.0345 0.0585)
+(0.0060 -0.0345 0.0585)
+(-0.0060 -0.0315 0.0585)
+(-0.0030 -0.0315 0.0585)
+(0.0000 -0.0315 0.0585)
+(0.0030 -0.0315 0.0585)
+(0.0060 -0.0315 0.0585)
+(-0.0060 -0.0285 0.0585)
+(-0.0030 -0.0285 0.0585)
+(0.0000 -0.0285 0.0585)
+(0.0030 -0.0285 0.0585)
+(0.0060 -0.0285 0.0585)
+(-0.0060 -0.0255 0.0585)
+(-0.0030 -0.0255 0.0585)
+(0.0000 -0.0255 0.0585)
+(0.0030 -0.0255 0.0585)
+(0.0060 -0.0255 0.0585)
+(-0.0060 -0.0225 0.0585)
+(-0.0030 -0.0225 0.0585)
+(0.0000 -0.0225 0.0585)
+(0.0030 -0.0225 0.0585)
+(0.0060 -0.0225 0.0585)
+(-0.0060 -0.0195 0.0585)
+(-0.0030 -0.0195 0.0585)
+(0.0000 -0.0195 0.0585)
+(0.0030 -0.0195 0.0585)
+(0.0060 -0.0195 0.0585)
+(-0.0060 -0.0165 0.0585)
+(-0.0030 -0.0165 0.0585)
+(0.0000 -0.0165 0.0585)
+(0.0030 -0.0165 0.0585)
+(0.0060 -0.0165 0.0585)
+(-0.0060 -0.0135 0.0585)
+(-0.0030 -0.0135 0.0585)
+(0.0000 -0.0135 0.0585)
+(0.0030 -0.0135 0.0585)
+(0.0060 -0.0135 0.0585)
+(-0.0060 -0.0105 0.0585)
+(-0.0030 -0.0105 0.0585)
+(0.0000 -0.0105 0.0585)
+(0.0030 -0.0105 0.0585)
+(0.0060 -0.0105 0.0585)
+(-0.0060 -0.0075 0.0585)
+(-0.0030 -0.0075 0.0585)
+(0.0000 -0.0075 0.0585)
+(0.0030 -0.0075 0.0585)
+(0.0060 -0.0075 0.0585)
+(-0.0060 -0.0045 0.0585)
+(-0.0030 -0.0045 0.0585)
+(0.0000 -0.0045 0.0585)
+(0.0030 -0.0045 0.0585)
+(0.0060 -0.0045 0.0585)
+(-0.0060 -0.0015 0.0585)
+(-0.0030 -0.0015 0.0585)
+(0.0000 -0.0015 0.0585)
+(0.0030 -0.0015 0.0585)
+(0.0060 -0.0015 0.0585)
+(-0.0060 0.0015 0.0585)
+(-0.0030 0.0015 0.0585)
+(0.0000 0.0015 0.0585)
+(0.0030 0.0015 0.0585)
+(0.0060 0.0015 0.0585)
+(-0.0060 0.0045 0.0585)
+(-0.0030 0.0045 0.0585)
+(0.0000 0.0045 0.0585)
+(0.0030 0.0045 0.0585)
+(0.0060 0.0045 0.0585)
+(-0.0060 0.0075 0.0585)
+(-0.0030 0.0075 0.0585)
+(0.0000 0.0075 0.0585)
+(0.0030 0.0075 0.0585)
+(0.0060 0.0075 0.0585)
+(-0.0060 0.0105 0.0585)
+(-0.0030 0.0105 0.0585)
+(0.0000 0.0105 0.0585)
+(0.0030 0.0105 0.0585)
+(0.0060 0.0105 0.0585)
+(-0.0060 0.0135 0.0585)
+(-0.0030 0.0135 0.0585)
+(0.0000 0.0135 0.0585)
+(0.0030 0.0135 0.0585)
+(0.0060 0.0135 0.0585)
+(-0.0060 0.0165 0.0585)
+(-0.0030 0.0165 0.0585)
+(0.0000 0.0165 0.0585)
+(0.0030 0.0165 0.0585)
+(0.0060 0.0165 0.0585)
+(-0.0060 0.0195 0.0585)
+(-0.0030 0.0195 0.0585)
+(0.0000 0.0195 0.0585)
+(0.0030 0.0195 0.0585)
+(0.0060 0.0195 0.0585)
+(-0.0060 0.0225 0.0585)
+(-0.0030 0.0225 0.0585)
+(0.0000 0.0225 0.0585)
+(0.0030 0.0225 0.0585)
+(0.0060 0.0225 0.0585)
+(-0.0060 0.0255 0.0585)
+(-0.0030 0.0255 0.0585)
+(0.0000 0.0255 0.0585)
+(0.0030 0.0255 0.0585)
+(0.0060 0.0255 0.0585)
+(-0.0060 0.0285 0.0585)
+(-0.0030 0.0285 0.0585)
+(0.0000 0.0285 0.0585)
+(0.0030 0.0285 0.0585)
+(0.0060 0.0285 0.0585)
+(-0.0060 0.0315 0.0585)
+(-0.0030 0.0315 0.0585)
+(0.0000 0.0315 0.0585)
+(0.0030 0.0315 0.0585)
+(0.0060 0.0315 0.0585)
+(-0.0060 0.0345 0.0585)
+(-0.0030 0.0345 0.0585)
+(0.0000 0.0345 0.0585)
+(0.0030 0.0345 0.0585)
+(0.0060 0.0345 0.0585)
+(-0.0060 0.0375 0.0585)
+(-0.0030 0.0375 0.0585)
+(0.0000 0.0375 0.0585)
+(0.0030 0.0375 0.0585)
+(0.0060 0.0375 0.0585)
+(-0.0060 0.0405 0.0585)
+(-0.0030 0.0405 0.0585)
+(0.0000 0.0405 0.0585)
+(0.0030 0.0405 0.0585)
+(0.0060 0.0405 0.0585)
+(-0.0060 0.0435 0.0585)
+(-0.0030 0.0435 0.0585)
+(0.0000 0.0435 0.0585)
+(0.0030 0.0435 0.0585)
+(0.0060 0.0435 0.0585)
+(-0.0060 0.0465 0.0585)
+(-0.0030 0.0465 0.0585)
+(0.0000 0.0465 0.0585)
+(0.0030 0.0465 0.0585)
+(0.0060 0.0465 0.0585)
+(-0.0060 0.0495 0.0585)
+(-0.0030 0.0495 0.0585)
+(0.0000 0.0495 0.0585)
+(0.0030 0.0495 0.0585)
+(0.0060 0.0495 0.0585)
+(-0.0060 0.0525 0.0585)
+(-0.0030 0.0525 0.0585)
+(0.0000 0.0525 0.0585)
+(0.0030 0.0525 0.0585)
+(0.0060 0.0525 0.0585)
+(-0.0060 0.0555 0.0585)
+(-0.0030 0.0555 0.0585)
+(0.0000 0.0555 0.0585)
+(0.0030 0.0555 0.0585)
+(0.0060 0.0555 0.0585)
+(-0.0060 0.0585 0.0585)
+(-0.0030 0.0585 0.0585)
+(0.0000 0.0585 0.0585)
+(0.0030 0.0585 0.0585)
+(0.0060 0.0585 0.0585)
+(-0.0060 0.0615 0.0585)
+(-0.0030 0.0615 0.0585)
+(0.0000 0.0615 0.0585)
+(0.0030 0.0615 0.0585)
+(0.0060 0.0615 0.0585)
+(-0.0060 0.0645 0.0585)
+(-0.0030 0.0645 0.0585)
+(0.0000 0.0645 0.0585)
+(0.0030 0.0645 0.0585)
+(0.0060 0.0645 0.0585)
+(-0.0060 0.0675 0.0585)
+(-0.0030 0.0675 0.0585)
+(0.0000 0.0675 0.0585)
+(0.0030 0.0675 0.0585)
+(0.0060 0.0675 0.0585)
+(-0.0060 0.0705 0.0585)
+(-0.0030 0.0705 0.0585)
+(0.0000 0.0705 0.0585)
+(0.0030 0.0705 0.0585)
+(0.0060 0.0705 0.0585)
+(-0.0060 0.0735 0.0585)
+(-0.0030 0.0735 0.0585)
+(0.0000 0.0735 0.0585)
+(0.0030 0.0735 0.0585)
+(0.0060 0.0735 0.0585)
+(-0.0060 -0.0735 0.0615)
+(-0.0030 -0.0735 0.0615)
+(0.0000 -0.0735 0.0615)
+(0.0030 -0.0735 0.0615)
+(0.0060 -0.0735 0.0615)
+(-0.0060 -0.0705 0.0615)
+(-0.0030 -0.0705 0.0615)
+(0.0000 -0.0705 0.0615)
+(0.0030 -0.0705 0.0615)
+(0.0060 -0.0705 0.0615)
+(-0.0060 -0.0675 0.0615)
+(-0.0030 -0.0675 0.0615)
+(0.0000 -0.0675 0.0615)
+(0.0030 -0.0675 0.0615)
+(0.0060 -0.0675 0.0615)
+(-0.0060 -0.0645 0.0615)
+(-0.0030 -0.0645 0.0615)
+(0.0000 -0.0645 0.0615)
+(0.0030 -0.0645 0.0615)
+(0.0060 -0.0645 0.0615)
+(-0.0060 -0.0615 0.0615)
+(-0.0030 -0.0615 0.0615)
+(0.0000 -0.0615 0.0615)
+(0.0030 -0.0615 0.0615)
+(0.0060 -0.0615 0.0615)
+(-0.0060 -0.0585 0.0615)
+(-0.0030 -0.0585 0.0615)
+(0.0000 -0.0585 0.0615)
+(0.0030 -0.0585 0.0615)
+(0.0060 -0.0585 0.0615)
+(-0.0060 -0.0555 0.0615)
+(-0.0030 -0.0555 0.0615)
+(0.0000 -0.0555 0.0615)
+(0.0030 -0.0555 0.0615)
+(0.0060 -0.0555 0.0615)
+(-0.0060 -0.0525 0.0615)
+(-0.0030 -0.0525 0.0615)
+(0.0000 -0.0525 0.0615)
+(0.0030 -0.0525 0.0615)
+(0.0060 -0.0525 0.0615)
+(-0.0060 -0.0495 0.0615)
+(-0.0030 -0.0495 0.0615)
+(0.0000 -0.0495 0.0615)
+(0.0030 -0.0495 0.0615)
+(0.0060 -0.0495 0.0615)
+(-0.0060 -0.0465 0.0615)
+(-0.0030 -0.0465 0.0615)
+(0.0000 -0.0465 0.0615)
+(0.0030 -0.0465 0.0615)
+(0.0060 -0.0465 0.0615)
+(-0.0060 -0.0435 0.0615)
+(-0.0030 -0.0435 0.0615)
+(0.0000 -0.0435 0.0615)
+(0.0030 -0.0435 0.0615)
+(0.0060 -0.0435 0.0615)
+(-0.0060 -0.0405 0.0615)
+(-0.0030 -0.0405 0.0615)
+(0.0000 -0.0405 0.0615)
+(0.0030 -0.0405 0.0615)
+(0.0060 -0.0405 0.0615)
+(-0.0060 -0.0375 0.0615)
+(-0.0030 -0.0375 0.0615)
+(0.0000 -0.0375 0.0615)
+(0.0030 -0.0375 0.0615)
+(0.0060 -0.0375 0.0615)
+(-0.0060 -0.0345 0.0615)
+(-0.0030 -0.0345 0.0615)
+(0.0000 -0.0345 0.0615)
+(0.0030 -0.0345 0.0615)
+(0.0060 -0.0345 0.0615)
+(-0.0060 -0.0315 0.0615)
+(-0.0030 -0.0315 0.0615)
+(0.0000 -0.0315 0.0615)
+(0.0030 -0.0315 0.0615)
+(0.0060 -0.0315 0.0615)
+(-0.0060 -0.0285 0.0615)
+(-0.0030 -0.0285 0.0615)
+(0.0000 -0.0285 0.0615)
+(0.0030 -0.0285 0.0615)
+(0.0060 -0.0285 0.0615)
+(-0.0060 -0.0255 0.0615)
+(-0.0030 -0.0255 0.0615)
+(0.0000 -0.0255 0.0615)
+(0.0030 -0.0255 0.0615)
+(0.0060 -0.0255 0.0615)
+(-0.0060 -0.0225 0.0615)
+(-0.0030 -0.0225 0.0615)
+(0.0000 -0.0225 0.0615)
+(0.0030 -0.0225 0.0615)
+(0.0060 -0.0225 0.0615)
+(-0.0060 -0.0195 0.0615)
+(-0.0030 -0.0195 0.0615)
+(0.0000 -0.0195 0.0615)
+(0.0030 -0.0195 0.0615)
+(0.0060 -0.0195 0.0615)
+(-0.0060 -0.0165 0.0615)
+(-0.0030 -0.0165 0.0615)
+(0.0000 -0.0165 0.0615)
+(0.0030 -0.0165 0.0615)
+(0.0060 -0.0165 0.0615)
+(-0.0060 -0.0135 0.0615)
+(-0.0030 -0.0135 0.0615)
+(0.0000 -0.0135 0.0615)
+(0.0030 -0.0135 0.0615)
+(0.0060 -0.0135 0.0615)
+(-0.0060 -0.0105 0.0615)
+(-0.0030 -0.0105 0.0615)
+(0.0000 -0.0105 0.0615)
+(0.0030 -0.0105 0.0615)
+(0.0060 -0.0105 0.0615)
+(-0.0060 -0.0075 0.0615)
+(-0.0030 -0.0075 0.0615)
+(0.0000 -0.0075 0.0615)
+(0.0030 -0.0075 0.0615)
+(0.0060 -0.0075 0.0615)
+(-0.0060 -0.0045 0.0615)
+(-0.0030 -0.0045 0.0615)
+(0.0000 -0.0045 0.0615)
+(0.0030 -0.0045 0.0615)
+(0.0060 -0.0045 0.0615)
+(-0.0060 -0.0015 0.0615)
+(-0.0030 -0.0015 0.0615)
+(0.0000 -0.0015 0.0615)
+(0.0030 -0.0015 0.0615)
+(0.0060 -0.0015 0.0615)
+(-0.0060 0.0015 0.0615)
+(-0.0030 0.0015 0.0615)
+(0.0000 0.0015 0.0615)
+(0.0030 0.0015 0.0615)
+(0.0060 0.0015 0.0615)
+(-0.0060 0.0045 0.0615)
+(-0.0030 0.0045 0.0615)
+(0.0000 0.0045 0.0615)
+(0.0030 0.0045 0.0615)
+(0.0060 0.0045 0.0615)
+(-0.0060 0.0075 0.0615)
+(-0.0030 0.0075 0.0615)
+(0.0000 0.0075 0.0615)
+(0.0030 0.0075 0.0615)
+(0.0060 0.0075 0.0615)
+(-0.0060 0.0105 0.0615)
+(-0.0030 0.0105 0.0615)
+(0.0000 0.0105 0.0615)
+(0.0030 0.0105 0.0615)
+(0.0060 0.0105 0.0615)
+(-0.0060 0.0135 0.0615)
+(-0.0030 0.0135 0.0615)
+(0.0000 0.0135 0.0615)
+(0.0030 0.0135 0.0615)
+(0.0060 0.0135 0.0615)
+(-0.0060 0.0165 0.0615)
+(-0.0030 0.0165 0.0615)
+(0.0000 0.0165 0.0615)
+(0.0030 0.0165 0.0615)
+(0.0060 0.0165 0.0615)
+(-0.0060 0.0195 0.0615)
+(-0.0030 0.0195 0.0615)
+(0.0000 0.0195 0.0615)
+(0.0030 0.0195 0.0615)
+(0.0060 0.0195 0.0615)
+(-0.0060 0.0225 0.0615)
+(-0.0030 0.0225 0.0615)
+(0.0000 0.0225 0.0615)
+(0.0030 0.0225 0.0615)
+(0.0060 0.0225 0.0615)
+(-0.0060 0.0255 0.0615)
+(-0.0030 0.0255 0.0615)
+(0.0000 0.0255 0.0615)
+(0.0030 0.0255 0.0615)
+(0.0060 0.0255 0.0615)
+(-0.0060 0.0285 0.0615)
+(-0.0030 0.0285 0.0615)
+(0.0000 0.0285 0.0615)
+(0.0030 0.0285 0.0615)
+(0.0060 0.0285 0.0615)
+(-0.0060 0.0315 0.0615)
+(-0.0030 0.0315 0.0615)
+(0.0000 0.0315 0.0615)
+(0.0030 0.0315 0.0615)
+(0.0060 0.0315 0.0615)
+(-0.0060 0.0345 0.0615)
+(-0.0030 0.0345 0.0615)
+(0.0000 0.0345 0.0615)
+(0.0030 0.0345 0.0615)
+(0.0060 0.0345 0.0615)
+(-0.0060 0.0375 0.0615)
+(-0.0030 0.0375 0.0615)
+(0.0000 0.0375 0.0615)
+(0.0030 0.0375 0.0615)
+(0.0060 0.0375 0.0615)
+(-0.0060 0.0405 0.0615)
+(-0.0030 0.0405 0.0615)
+(0.0000 0.0405 0.0615)
+(0.0030 0.0405 0.0615)
+(0.0060 0.0405 0.0615)
+(-0.0060 0.0435 0.0615)
+(-0.0030 0.0435 0.0615)
+(0.0000 0.0435 0.0615)
+(0.0030 0.0435 0.0615)
+(0.0060 0.0435 0.0615)
+(-0.0060 0.0465 0.0615)
+(-0.0030 0.0465 0.0615)
+(0.0000 0.0465 0.0615)
+(0.0030 0.0465 0.0615)
+(0.0060 0.0465 0.0615)
+(-0.0060 0.0495 0.0615)
+(-0.0030 0.0495 0.0615)
+(0.0000 0.0495 0.0615)
+(0.0030 0.0495 0.0615)
+(0.0060 0.0495 0.0615)
+(-0.0060 0.0525 0.0615)
+(-0.0030 0.0525 0.0615)
+(0.0000 0.0525 0.0615)
+(0.0030 0.0525 0.0615)
+(0.0060 0.0525 0.0615)
+(-0.0060 0.0555 0.0615)
+(-0.0030 0.0555 0.0615)
+(0.0000 0.0555 0.0615)
+(0.0030 0.0555 0.0615)
+(0.0060 0.0555 0.0615)
+(-0.0060 0.0585 0.0615)
+(-0.0030 0.0585 0.0615)
+(0.0000 0.0585 0.0615)
+(0.0030 0.0585 0.0615)
+(0.0060 0.0585 0.0615)
+(-0.0060 0.0615 0.0615)
+(-0.0030 0.0615 0.0615)
+(0.0000 0.0615 0.0615)
+(0.0030 0.0615 0.0615)
+(0.0060 0.0615 0.0615)
+(-0.0060 0.0645 0.0615)
+(-0.0030 0.0645 0.0615)
+(0.0000 0.0645 0.0615)
+(0.0030 0.0645 0.0615)
+(0.0060 0.0645 0.0615)
+(-0.0060 0.0675 0.0615)
+(-0.0030 0.0675 0.0615)
+(0.0000 0.0675 0.0615)
+(0.0030 0.0675 0.0615)
+(0.0060 0.0675 0.0615)
+(-0.0060 0.0705 0.0615)
+(-0.0030 0.0705 0.0615)
+(0.0000 0.0705 0.0615)
+(0.0030 0.0705 0.0615)
+(0.0060 0.0705 0.0615)
+(-0.0060 0.0735 0.0615)
+(-0.0030 0.0735 0.0615)
+(0.0000 0.0735 0.0615)
+(0.0030 0.0735 0.0615)
+(0.0060 0.0735 0.0615)
+(-0.0060 -0.0735 0.0645)
+(-0.0030 -0.0735 0.0645)
+(0.0000 -0.0735 0.0645)
+(0.0030 -0.0735 0.0645)
+(0.0060 -0.0735 0.0645)
+(-0.0060 -0.0705 0.0645)
+(-0.0030 -0.0705 0.0645)
+(0.0000 -0.0705 0.0645)
+(0.0030 -0.0705 0.0645)
+(0.0060 -0.0705 0.0645)
+(-0.0060 -0.0675 0.0645)
+(-0.0030 -0.0675 0.0645)
+(0.0000 -0.0675 0.0645)
+(0.0030 -0.0675 0.0645)
+(0.0060 -0.0675 0.0645)
+(-0.0060 -0.0645 0.0645)
+(-0.0030 -0.0645 0.0645)
+(0.0000 -0.0645 0.0645)
+(0.0030 -0.0645 0.0645)
+(0.0060 -0.0645 0.0645)
+(-0.0060 -0.0615 0.0645)
+(-0.0030 -0.0615 0.0645)
+(0.0000 -0.0615 0.0645)
+(0.0030 -0.0615 0.0645)
+(0.0060 -0.0615 0.0645)
+(-0.0060 -0.0585 0.0645)
+(-0.0030 -0.0585 0.0645)
+(0.0000 -0.0585 0.0645)
+(0.0030 -0.0585 0.0645)
+(0.0060 -0.0585 0.0645)
+(-0.0060 -0.0555 0.0645)
+(-0.0030 -0.0555 0.0645)
+(0.0000 -0.0555 0.0645)
+(0.0030 -0.0555 0.0645)
+(0.0060 -0.0555 0.0645)
+(-0.0060 -0.0525 0.0645)
+(-0.0030 -0.0525 0.0645)
+(0.0000 -0.0525 0.0645)
+(0.0030 -0.0525 0.0645)
+(0.0060 -0.0525 0.0645)
+(-0.0060 -0.0495 0.0645)
+(-0.0030 -0.0495 0.0645)
+(0.0000 -0.0495 0.0645)
+(0.0030 -0.0495 0.0645)
+(0.0060 -0.0495 0.0645)
+(-0.0060 -0.0465 0.0645)
+(-0.0030 -0.0465 0.0645)
+(0.0000 -0.0465 0.0645)
+(0.0030 -0.0465 0.0645)
+(0.0060 -0.0465 0.0645)
+(-0.0060 -0.0435 0.0645)
+(-0.0030 -0.0435 0.0645)
+(0.0000 -0.0435 0.0645)
+(0.0030 -0.0435 0.0645)
+(0.0060 -0.0435 0.0645)
+(-0.0060 -0.0405 0.0645)
+(-0.0030 -0.0405 0.0645)
+(0.0000 -0.0405 0.0645)
+(0.0030 -0.0405 0.0645)
+(0.0060 -0.0405 0.0645)
+(-0.0060 -0.0375 0.0645)
+(-0.0030 -0.0375 0.0645)
+(0.0000 -0.0375 0.0645)
+(0.0030 -0.0375 0.0645)
+(0.0060 -0.0375 0.0645)
+(-0.0060 -0.0345 0.0645)
+(-0.0030 -0.0345 0.0645)
+(0.0000 -0.0345 0.0645)
+(0.0030 -0.0345 0.0645)
+(0.0060 -0.0345 0.0645)
+(-0.0060 -0.0315 0.0645)
+(-0.0030 -0.0315 0.0645)
+(0.0000 -0.0315 0.0645)
+(0.0030 -0.0315 0.0645)
+(0.0060 -0.0315 0.0645)
+(-0.0060 -0.0285 0.0645)
+(-0.0030 -0.0285 0.0645)
+(0.0000 -0.0285 0.0645)
+(0.0030 -0.0285 0.0645)
+(0.0060 -0.0285 0.0645)
+(-0.0060 -0.0255 0.0645)
+(-0.0030 -0.0255 0.0645)
+(0.0000 -0.0255 0.0645)
+(0.0030 -0.0255 0.0645)
+(0.0060 -0.0255 0.0645)
+(-0.0060 -0.0225 0.0645)
+(-0.0030 -0.0225 0.0645)
+(0.0000 -0.0225 0.0645)
+(0.0030 -0.0225 0.0645)
+(0.0060 -0.0225 0.0645)
+(-0.0060 -0.0195 0.0645)
+(-0.0030 -0.0195 0.0645)
+(0.0000 -0.0195 0.0645)
+(0.0030 -0.0195 0.0645)
+(0.0060 -0.0195 0.0645)
+(-0.0060 -0.0165 0.0645)
+(-0.0030 -0.0165 0.0645)
+(0.0000 -0.0165 0.0645)
+(0.0030 -0.0165 0.0645)
+(0.0060 -0.0165 0.0645)
+(-0.0060 -0.0135 0.0645)
+(-0.0030 -0.0135 0.0645)
+(0.0000 -0.0135 0.0645)
+(0.0030 -0.0135 0.0645)
+(0.0060 -0.0135 0.0645)
+(-0.0060 -0.0105 0.0645)
+(-0.0030 -0.0105 0.0645)
+(0.0000 -0.0105 0.0645)
+(0.0030 -0.0105 0.0645)
+(0.0060 -0.0105 0.0645)
+(-0.0060 -0.0075 0.0645)
+(-0.0030 -0.0075 0.0645)
+(0.0000 -0.0075 0.0645)
+(0.0030 -0.0075 0.0645)
+(0.0060 -0.0075 0.0645)
+(-0.0060 -0.0045 0.0645)
+(-0.0030 -0.0045 0.0645)
+(0.0000 -0.0045 0.0645)
+(0.0030 -0.0045 0.0645)
+(0.0060 -0.0045 0.0645)
+(-0.0060 -0.0015 0.0645)
+(-0.0030 -0.0015 0.0645)
+(0.0000 -0.0015 0.0645)
+(0.0030 -0.0015 0.0645)
+(0.0060 -0.0015 0.0645)
+(-0.0060 0.0015 0.0645)
+(-0.0030 0.0015 0.0645)
+(0.0000 0.0015 0.0645)
+(0.0030 0.0015 0.0645)
+(0.0060 0.0015 0.0645)
+(-0.0060 0.0045 0.0645)
+(-0.0030 0.0045 0.0645)
+(0.0000 0.0045 0.0645)
+(0.0030 0.0045 0.0645)
+(0.0060 0.0045 0.0645)
+(-0.0060 0.0075 0.0645)
+(-0.0030 0.0075 0.0645)
+(0.0000 0.0075 0.0645)
+(0.0030 0.0075 0.0645)
+(0.0060 0.0075 0.0645)
+(-0.0060 0.0105 0.0645)
+(-0.0030 0.0105 0.0645)
+(0.0000 0.0105 0.0645)
+(0.0030 0.0105 0.0645)
+(0.0060 0.0105 0.0645)
+(-0.0060 0.0135 0.0645)
+(-0.0030 0.0135 0.0645)
+(0.0000 0.0135 0.0645)
+(0.0030 0.0135 0.0645)
+(0.0060 0.0135 0.0645)
+(-0.0060 0.0165 0.0645)
+(-0.0030 0.0165 0.0645)
+(0.0000 0.0165 0.0645)
+(0.0030 0.0165 0.0645)
+(0.0060 0.0165 0.0645)
+(-0.0060 0.0195 0.0645)
+(-0.0030 0.0195 0.0645)
+(0.0000 0.0195 0.0645)
+(0.0030 0.0195 0.0645)
+(0.0060 0.0195 0.0645)
+(-0.0060 0.0225 0.0645)
+(-0.0030 0.0225 0.0645)
+(0.0000 0.0225 0.0645)
+(0.0030 0.0225 0.0645)
+(0.0060 0.0225 0.0645)
+(-0.0060 0.0255 0.0645)
+(-0.0030 0.0255 0.0645)
+(0.0000 0.0255 0.0645)
+(0.0030 0.0255 0.0645)
+(0.0060 0.0255 0.0645)
+(-0.0060 0.0285 0.0645)
+(-0.0030 0.0285 0.0645)
+(0.0000 0.0285 0.0645)
+(0.0030 0.0285 0.0645)
+(0.0060 0.0285 0.0645)
+(-0.0060 0.0315 0.0645)
+(-0.0030 0.0315 0.0645)
+(0.0000 0.0315 0.0645)
+(0.0030 0.0315 0.0645)
+(0.0060 0.0315 0.0645)
+(-0.0060 0.0345 0.0645)
+(-0.0030 0.0345 0.0645)
+(0.0000 0.0345 0.0645)
+(0.0030 0.0345 0.0645)
+(0.0060 0.0345 0.0645)
+(-0.0060 0.0375 0.0645)
+(-0.0030 0.0375 0.0645)
+(0.0000 0.0375 0.0645)
+(0.0030 0.0375 0.0645)
+(0.0060 0.0375 0.0645)
+(-0.0060 0.0405 0.0645)
+(-0.0030 0.0405 0.0645)
+(0.0000 0.0405 0.0645)
+(0.0030 0.0405 0.0645)
+(0.0060 0.0405 0.0645)
+(-0.0060 0.0435 0.0645)
+(-0.0030 0.0435 0.0645)
+(0.0000 0.0435 0.0645)
+(0.0030 0.0435 0.0645)
+(0.0060 0.0435 0.0645)
+(-0.0060 0.0465 0.0645)
+(-0.0030 0.0465 0.0645)
+(0.0000 0.0465 0.0645)
+(0.0030 0.0465 0.0645)
+(0.0060 0.0465 0.0645)
+(-0.0060 0.0495 0.0645)
+(-0.0030 0.0495 0.0645)
+(0.0000 0.0495 0.0645)
+(0.0030 0.0495 0.0645)
+(0.0060 0.0495 0.0645)
+(-0.0060 0.0525 0.0645)
+(-0.0030 0.0525 0.0645)
+(0.0000 0.0525 0.0645)
+(0.0030 0.0525 0.0645)
+(0.0060 0.0525 0.0645)
+(-0.0060 0.0555 0.0645)
+(-0.0030 0.0555 0.0645)
+(0.0000 0.0555 0.0645)
+(0.0030 0.0555 0.0645)
+(0.0060 0.0555 0.0645)
+(-0.0060 0.0585 0.0645)
+(-0.0030 0.0585 0.0645)
+(0.0000 0.0585 0.0645)
+(0.0030 0.0585 0.0645)
+(0.0060 0.0585 0.0645)
+(-0.0060 0.0615 0.0645)
+(-0.0030 0.0615 0.0645)
+(0.0000 0.0615 0.0645)
+(0.0030 0.0615 0.0645)
+(0.0060 0.0615 0.0645)
+(-0.0060 0.0645 0.0645)
+(-0.0030 0.0645 0.0645)
+(0.0000 0.0645 0.0645)
+(0.0030 0.0645 0.0645)
+(0.0060 0.0645 0.0645)
+(-0.0060 0.0675 0.0645)
+(-0.0030 0.0675 0.0645)
+(0.0000 0.0675 0.0645)
+(0.0030 0.0675 0.0645)
+(0.0060 0.0675 0.0645)
+(-0.0060 0.0705 0.0645)
+(-0.0030 0.0705 0.0645)
+(0.0000 0.0705 0.0645)
+(0.0030 0.0705 0.0645)
+(0.0060 0.0705 0.0645)
+(-0.0060 0.0735 0.0645)
+(-0.0030 0.0735 0.0645)
+(0.0000 0.0735 0.0645)
+(0.0030 0.0735 0.0645)
+(0.0060 0.0735 0.0645)
+(-0.0060 -0.0735 0.0675)
+(-0.0030 -0.0735 0.0675)
+(0.0000 -0.0735 0.0675)
+(0.0030 -0.0735 0.0675)
+(0.0060 -0.0735 0.0675)
+(-0.0060 -0.0705 0.0675)
+(-0.0030 -0.0705 0.0675)
+(0.0000 -0.0705 0.0675)
+(0.0030 -0.0705 0.0675)
+(0.0060 -0.0705 0.0675)
+(-0.0060 -0.0675 0.0675)
+(-0.0030 -0.0675 0.0675)
+(0.0000 -0.0675 0.0675)
+(0.0030 -0.0675 0.0675)
+(0.0060 -0.0675 0.0675)
+(-0.0060 -0.0645 0.0675)
+(-0.0030 -0.0645 0.0675)
+(0.0000 -0.0645 0.0675)
+(0.0030 -0.0645 0.0675)
+(0.0060 -0.0645 0.0675)
+(-0.0060 -0.0615 0.0675)
+(-0.0030 -0.0615 0.0675)
+(0.0000 -0.0615 0.0675)
+(0.0030 -0.0615 0.0675)
+(0.0060 -0.0615 0.0675)
+(-0.0060 -0.0585 0.0675)
+(-0.0030 -0.0585 0.0675)
+(0.0000 -0.0585 0.0675)
+(0.0030 -0.0585 0.0675)
+(0.0060 -0.0585 0.0675)
+(-0.0060 -0.0555 0.0675)
+(-0.0030 -0.0555 0.0675)
+(0.0000 -0.0555 0.0675)
+(0.0030 -0.0555 0.0675)
+(0.0060 -0.0555 0.0675)
+(-0.0060 -0.0525 0.0675)
+(-0.0030 -0.0525 0.0675)
+(0.0000 -0.0525 0.0675)
+(0.0030 -0.0525 0.0675)
+(0.0060 -0.0525 0.0675)
+(-0.0060 -0.0495 0.0675)
+(-0.0030 -0.0495 0.0675)
+(0.0000 -0.0495 0.0675)
+(0.0030 -0.0495 0.0675)
+(0.0060 -0.0495 0.0675)
+(-0.0060 -0.0465 0.0675)
+(-0.0030 -0.0465 0.0675)
+(0.0000 -0.0465 0.0675)
+(0.0030 -0.0465 0.0675)
+(0.0060 -0.0465 0.0675)
+(-0.0060 -0.0435 0.0675)
+(-0.0030 -0.0435 0.0675)
+(0.0000 -0.0435 0.0675)
+(0.0030 -0.0435 0.0675)
+(0.0060 -0.0435 0.0675)
+(-0.0060 -0.0405 0.0675)
+(-0.0030 -0.0405 0.0675)
+(0.0000 -0.0405 0.0675)
+(0.0030 -0.0405 0.0675)
+(0.0060 -0.0405 0.0675)
+(-0.0060 -0.0375 0.0675)
+(-0.0030 -0.0375 0.0675)
+(0.0000 -0.0375 0.0675)
+(0.0030 -0.0375 0.0675)
+(0.0060 -0.0375 0.0675)
+(-0.0060 -0.0345 0.0675)
+(-0.0030 -0.0345 0.0675)
+(0.0000 -0.0345 0.0675)
+(0.0030 -0.0345 0.0675)
+(0.0060 -0.0345 0.0675)
+(-0.0060 -0.0315 0.0675)
+(-0.0030 -0.0315 0.0675)
+(0.0000 -0.0315 0.0675)
+(0.0030 -0.0315 0.0675)
+(0.0060 -0.0315 0.0675)
+(-0.0060 -0.0285 0.0675)
+(-0.0030 -0.0285 0.0675)
+(0.0000 -0.0285 0.0675)
+(0.0030 -0.0285 0.0675)
+(0.0060 -0.0285 0.0675)
+(-0.0060 -0.0255 0.0675)
+(-0.0030 -0.0255 0.0675)
+(0.0000 -0.0255 0.0675)
+(0.0030 -0.0255 0.0675)
+(0.0060 -0.0255 0.0675)
+(-0.0060 -0.0225 0.0675)
+(-0.0030 -0.0225 0.0675)
+(0.0000 -0.0225 0.0675)
+(0.0030 -0.0225 0.0675)
+(0.0060 -0.0225 0.0675)
+(-0.0060 -0.0195 0.0675)
+(-0.0030 -0.0195 0.0675)
+(0.0000 -0.0195 0.0675)
+(0.0030 -0.0195 0.0675)
+(0.0060 -0.0195 0.0675)
+(-0.0060 -0.0165 0.0675)
+(-0.0030 -0.0165 0.0675)
+(0.0000 -0.0165 0.0675)
+(0.0030 -0.0165 0.0675)
+(0.0060 -0.0165 0.0675)
+(-0.0060 -0.0135 0.0675)
+(-0.0030 -0.0135 0.0675)
+(0.0000 -0.0135 0.0675)
+(0.0030 -0.0135 0.0675)
+(0.0060 -0.0135 0.0675)
+(-0.0060 -0.0105 0.0675)
+(-0.0030 -0.0105 0.0675)
+(0.0000 -0.0105 0.0675)
+(0.0030 -0.0105 0.0675)
+(0.0060 -0.0105 0.0675)
+(-0.0060 -0.0075 0.0675)
+(-0.0030 -0.0075 0.0675)
+(0.0000 -0.0075 0.0675)
+(0.0030 -0.0075 0.0675)
+(0.0060 -0.0075 0.0675)
+(-0.0060 -0.0045 0.0675)
+(-0.0030 -0.0045 0.0675)
+(0.0000 -0.0045 0.0675)
+(0.0030 -0.0045 0.0675)
+(0.0060 -0.0045 0.0675)
+(-0.0060 -0.0015 0.0675)
+(-0.0030 -0.0015 0.0675)
+(0.0000 -0.0015 0.0675)
+(0.0030 -0.0015 0.0675)
+(0.0060 -0.0015 0.0675)
+(-0.0060 0.0015 0.0675)
+(-0.0030 0.0015 0.0675)
+(0.0000 0.0015 0.0675)
+(0.0030 0.0015 0.0675)
+(0.0060 0.0015 0.0675)
+(-0.0060 0.0045 0.0675)
+(-0.0030 0.0045 0.0675)
+(0.0000 0.0045 0.0675)
+(0.0030 0.0045 0.0675)
+(0.0060 0.0045 0.0675)
+(-0.0060 0.0075 0.0675)
+(-0.0030 0.0075 0.0675)
+(0.0000 0.0075 0.0675)
+(0.0030 0.0075 0.0675)
+(0.0060 0.0075 0.0675)
+(-0.0060 0.0105 0.0675)
+(-0.0030 0.0105 0.0675)
+(0.0000 0.0105 0.0675)
+(0.0030 0.0105 0.0675)
+(0.0060 0.0105 0.0675)
+(-0.0060 0.0135 0.0675)
+(-0.0030 0.0135 0.0675)
+(0.0000 0.0135 0.0675)
+(0.0030 0.0135 0.0675)
+(0.0060 0.0135 0.0675)
+(-0.0060 0.0165 0.0675)
+(-0.0030 0.0165 0.0675)
+(0.0000 0.0165 0.0675)
+(0.0030 0.0165 0.0675)
+(0.0060 0.0165 0.0675)
+(-0.0060 0.0195 0.0675)
+(-0.0030 0.0195 0.0675)
+(0.0000 0.0195 0.0675)
+(0.0030 0.0195 0.0675)
+(0.0060 0.0195 0.0675)
+(-0.0060 0.0225 0.0675)
+(-0.0030 0.0225 0.0675)
+(0.0000 0.0225 0.0675)
+(0.0030 0.0225 0.0675)
+(0.0060 0.0225 0.0675)
+(-0.0060 0.0255 0.0675)
+(-0.0030 0.0255 0.0675)
+(0.0000 0.0255 0.0675)
+(0.0030 0.0255 0.0675)
+(0.0060 0.0255 0.0675)
+(-0.0060 0.0285 0.0675)
+(-0.0030 0.0285 0.0675)
+(0.0000 0.0285 0.0675)
+(0.0030 0.0285 0.0675)
+(0.0060 0.0285 0.0675)
+(-0.0060 0.0315 0.0675)
+(-0.0030 0.0315 0.0675)
+(0.0000 0.0315 0.0675)
+(0.0030 0.0315 0.0675)
+(0.0060 0.0315 0.0675)
+(-0.0060 0.0345 0.0675)
+(-0.0030 0.0345 0.0675)
+(0.0000 0.0345 0.0675)
+(0.0030 0.0345 0.0675)
+(0.0060 0.0345 0.0675)
+(-0.0060 0.0375 0.0675)
+(-0.0030 0.0375 0.0675)
+(0.0000 0.0375 0.0675)
+(0.0030 0.0375 0.0675)
+(0.0060 0.0375 0.0675)
+(-0.0060 0.0405 0.0675)
+(-0.0030 0.0405 0.0675)
+(0.0000 0.0405 0.0675)
+(0.0030 0.0405 0.0675)
+(0.0060 0.0405 0.0675)
+(-0.0060 0.0435 0.0675)
+(-0.0030 0.0435 0.0675)
+(0.0000 0.0435 0.0675)
+(0.0030 0.0435 0.0675)
+(0.0060 0.0435 0.0675)
+(-0.0060 0.0465 0.0675)
+(-0.0030 0.0465 0.0675)
+(0.0000 0.0465 0.0675)
+(0.0030 0.0465 0.0675)
+(0.0060 0.0465 0.0675)
+(-0.0060 0.0495 0.0675)
+(-0.0030 0.0495 0.0675)
+(0.0000 0.0495 0.0675)
+(0.0030 0.0495 0.0675)
+(0.0060 0.0495 0.0675)
+(-0.0060 0.0525 0.0675)
+(-0.0030 0.0525 0.0675)
+(0.0000 0.0525 0.0675)
+(0.0030 0.0525 0.0675)
+(0.0060 0.0525 0.0675)
+(-0.0060 0.0555 0.0675)
+(-0.0030 0.0555 0.0675)
+(0.0000 0.0555 0.0675)
+(0.0030 0.0555 0.0675)
+(0.0060 0.0555 0.0675)
+(-0.0060 0.0585 0.0675)
+(-0.0030 0.0585 0.0675)
+(0.0000 0.0585 0.0675)
+(0.0030 0.0585 0.0675)
+(0.0060 0.0585 0.0675)
+(-0.0060 0.0615 0.0675)
+(-0.0030 0.0615 0.0675)
+(0.0000 0.0615 0.0675)
+(0.0030 0.0615 0.0675)
+(0.0060 0.0615 0.0675)
+(-0.0060 0.0645 0.0675)
+(-0.0030 0.0645 0.0675)
+(0.0000 0.0645 0.0675)
+(0.0030 0.0645 0.0675)
+(0.0060 0.0645 0.0675)
+(-0.0060 0.0675 0.0675)
+(-0.0030 0.0675 0.0675)
+(0.0000 0.0675 0.0675)
+(0.0030 0.0675 0.0675)
+(0.0060 0.0675 0.0675)
+(-0.0060 0.0705 0.0675)
+(-0.0030 0.0705 0.0675)
+(0.0000 0.0705 0.0675)
+(0.0030 0.0705 0.0675)
+(0.0060 0.0705 0.0675)
+(-0.0060 0.0735 0.0675)
+(-0.0030 0.0735 0.0675)
+(0.0000 0.0735 0.0675)
+(0.0030 0.0735 0.0675)
+(0.0060 0.0735 0.0675)
+(-0.0060 -0.0735 0.0705)
+(-0.0030 -0.0735 0.0705)
+(0.0000 -0.0735 0.0705)
+(0.0030 -0.0735 0.0705)
+(0.0060 -0.0735 0.0705)
+(-0.0060 -0.0705 0.0705)
+(-0.0030 -0.0705 0.0705)
+(0.0000 -0.0705 0.0705)
+(0.0030 -0.0705 0.0705)
+(0.0060 -0.0705 0.0705)
+(-0.0060 -0.0675 0.0705)
+(-0.0030 -0.0675 0.0705)
+(0.0000 -0.0675 0.0705)
+(0.0030 -0.0675 0.0705)
+(0.0060 -0.0675 0.0705)
+(-0.0060 -0.0645 0.0705)
+(-0.0030 -0.0645 0.0705)
+(0.0000 -0.0645 0.0705)
+(0.0030 -0.0645 0.0705)
+(0.0060 -0.0645 0.0705)
+(-0.0060 -0.0615 0.0705)
+(-0.0030 -0.0615 0.0705)
+(0.0000 -0.0615 0.0705)
+(0.0030 -0.0615 0.0705)
+(0.0060 -0.0615 0.0705)
+(-0.0060 -0.0585 0.0705)
+(-0.0030 -0.0585 0.0705)
+(0.0000 -0.0585 0.0705)
+(0.0030 -0.0585 0.0705)
+(0.0060 -0.0585 0.0705)
+(-0.0060 -0.0555 0.0705)
+(-0.0030 -0.0555 0.0705)
+(0.0000 -0.0555 0.0705)
+(0.0030 -0.0555 0.0705)
+(0.0060 -0.0555 0.0705)
+(-0.0060 -0.0525 0.0705)
+(-0.0030 -0.0525 0.0705)
+(0.0000 -0.0525 0.0705)
+(0.0030 -0.0525 0.0705)
+(0.0060 -0.0525 0.0705)
+(-0.0060 -0.0495 0.0705)
+(-0.0030 -0.0495 0.0705)
+(0.0000 -0.0495 0.0705)
+(0.0030 -0.0495 0.0705)
+(0.0060 -0.0495 0.0705)
+(-0.0060 -0.0465 0.0705)
+(-0.0030 -0.0465 0.0705)
+(0.0000 -0.0465 0.0705)
+(0.0030 -0.0465 0.0705)
+(0.0060 -0.0465 0.0705)
+(-0.0060 -0.0435 0.0705)
+(-0.0030 -0.0435 0.0705)
+(0.0000 -0.0435 0.0705)
+(0.0030 -0.0435 0.0705)
+(0.0060 -0.0435 0.0705)
+(-0.0060 -0.0405 0.0705)
+(-0.0030 -0.0405 0.0705)
+(0.0000 -0.0405 0.0705)
+(0.0030 -0.0405 0.0705)
+(0.0060 -0.0405 0.0705)
+(-0.0060 -0.0375 0.0705)
+(-0.0030 -0.0375 0.0705)
+(0.0000 -0.0375 0.0705)
+(0.0030 -0.0375 0.0705)
+(0.0060 -0.0375 0.0705)
+(-0.0060 -0.0345 0.0705)
+(-0.0030 -0.0345 0.0705)
+(0.0000 -0.0345 0.0705)
+(0.0030 -0.0345 0.0705)
+(0.0060 -0.0345 0.0705)
+(-0.0060 -0.0315 0.0705)
+(-0.0030 -0.0315 0.0705)
+(0.0000 -0.0315 0.0705)
+(0.0030 -0.0315 0.0705)
+(0.0060 -0.0315 0.0705)
+(-0.0060 -0.0285 0.0705)
+(-0.0030 -0.0285 0.0705)
+(0.0000 -0.0285 0.0705)
+(0.0030 -0.0285 0.0705)
+(0.0060 -0.0285 0.0705)
+(-0.0060 -0.0255 0.0705)
+(-0.0030 -0.0255 0.0705)
+(0.0000 -0.0255 0.0705)
+(0.0030 -0.0255 0.0705)
+(0.0060 -0.0255 0.0705)
+(-0.0060 -0.0225 0.0705)
+(-0.0030 -0.0225 0.0705)
+(0.0000 -0.0225 0.0705)
+(0.0030 -0.0225 0.0705)
+(0.0060 -0.0225 0.0705)
+(-0.0060 -0.0195 0.0705)
+(-0.0030 -0.0195 0.0705)
+(0.0000 -0.0195 0.0705)
+(0.0030 -0.0195 0.0705)
+(0.0060 -0.0195 0.0705)
+(-0.0060 -0.0165 0.0705)
+(-0.0030 -0.0165 0.0705)
+(0.0000 -0.0165 0.0705)
+(0.0030 -0.0165 0.0705)
+(0.0060 -0.0165 0.0705)
+(-0.0060 -0.0135 0.0705)
+(-0.0030 -0.0135 0.0705)
+(0.0000 -0.0135 0.0705)
+(0.0030 -0.0135 0.0705)
+(0.0060 -0.0135 0.0705)
+(-0.0060 -0.0105 0.0705)
+(-0.0030 -0.0105 0.0705)
+(0.0000 -0.0105 0.0705)
+(0.0030 -0.0105 0.0705)
+(0.0060 -0.0105 0.0705)
+(-0.0060 -0.0075 0.0705)
+(-0.0030 -0.0075 0.0705)
+(0.0000 -0.0075 0.0705)
+(0.0030 -0.0075 0.0705)
+(0.0060 -0.0075 0.0705)
+(-0.0060 -0.0045 0.0705)
+(-0.0030 -0.0045 0.0705)
+(0.0000 -0.0045 0.0705)
+(0.0030 -0.0045 0.0705)
+(0.0060 -0.0045 0.0705)
+(-0.0060 -0.0015 0.0705)
+(-0.0030 -0.0015 0.0705)
+(0.0000 -0.0015 0.0705)
+(0.0030 -0.0015 0.0705)
+(0.0060 -0.0015 0.0705)
+(-0.0060 0.0015 0.0705)
+(-0.0030 0.0015 0.0705)
+(0.0000 0.0015 0.0705)
+(0.0030 0.0015 0.0705)
+(0.0060 0.0015 0.0705)
+(-0.0060 0.0045 0.0705)
+(-0.0030 0.0045 0.0705)
+(0.0000 0.0045 0.0705)
+(0.0030 0.0045 0.0705)
+(0.0060 0.0045 0.0705)
+(-0.0060 0.0075 0.0705)
+(-0.0030 0.0075 0.0705)
+(0.0000 0.0075 0.0705)
+(0.0030 0.0075 0.0705)
+(0.0060 0.0075 0.0705)
+(-0.0060 0.0105 0.0705)
+(-0.0030 0.0105 0.0705)
+(0.0000 0.0105 0.0705)
+(0.0030 0.0105 0.0705)
+(0.0060 0.0105 0.0705)
+(-0.0060 0.0135 0.0705)
+(-0.0030 0.0135 0.0705)
+(0.0000 0.0135 0.0705)
+(0.0030 0.0135 0.0705)
+(0.0060 0.0135 0.0705)
+(-0.0060 0.0165 0.0705)
+(-0.0030 0.0165 0.0705)
+(0.0000 0.0165 0.0705)
+(0.0030 0.0165 0.0705)
+(0.0060 0.0165 0.0705)
+(-0.0060 0.0195 0.0705)
+(-0.0030 0.0195 0.0705)
+(0.0000 0.0195 0.0705)
+(0.0030 0.0195 0.0705)
+(0.0060 0.0195 0.0705)
+(-0.0060 0.0225 0.0705)
+(-0.0030 0.0225 0.0705)
+(0.0000 0.0225 0.0705)
+(0.0030 0.0225 0.0705)
+(0.0060 0.0225 0.0705)
+(-0.0060 0.0255 0.0705)
+(-0.0030 0.0255 0.0705)
+(0.0000 0.0255 0.0705)
+(0.0030 0.0255 0.0705)
+(0.0060 0.0255 0.0705)
+(-0.0060 0.0285 0.0705)
+(-0.0030 0.0285 0.0705)
+(0.0000 0.0285 0.0705)
+(0.0030 0.0285 0.0705)
+(0.0060 0.0285 0.0705)
+(-0.0060 0.0315 0.0705)
+(-0.0030 0.0315 0.0705)
+(0.0000 0.0315 0.0705)
+(0.0030 0.0315 0.0705)
+(0.0060 0.0315 0.0705)
+(-0.0060 0.0345 0.0705)
+(-0.0030 0.0345 0.0705)
+(0.0000 0.0345 0.0705)
+(0.0030 0.0345 0.0705)
+(0.0060 0.0345 0.0705)
+(-0.0060 0.0375 0.0705)
+(-0.0030 0.0375 0.0705)
+(0.0000 0.0375 0.0705)
+(0.0030 0.0375 0.0705)
+(0.0060 0.0375 0.0705)
+(-0.0060 0.0405 0.0705)
+(-0.0030 0.0405 0.0705)
+(0.0000 0.0405 0.0705)
+(0.0030 0.0405 0.0705)
+(0.0060 0.0405 0.0705)
+(-0.0060 0.0435 0.0705)
+(-0.0030 0.0435 0.0705)
+(0.0000 0.0435 0.0705)
+(0.0030 0.0435 0.0705)
+(0.0060 0.0435 0.0705)
+(-0.0060 0.0465 0.0705)
+(-0.0030 0.0465 0.0705)
+(0.0000 0.0465 0.0705)
+(0.0030 0.0465 0.0705)
+(0.0060 0.0465 0.0705)
+(-0.0060 0.0495 0.0705)
+(-0.0030 0.0495 0.0705)
+(0.0000 0.0495 0.0705)
+(0.0030 0.0495 0.0705)
+(0.0060 0.0495 0.0705)
+(-0.0060 0.0525 0.0705)
+(-0.0030 0.0525 0.0705)
+(0.0000 0.0525 0.0705)
+(0.0030 0.0525 0.0705)
+(0.0060 0.0525 0.0705)
+(-0.0060 0.0555 0.0705)
+(-0.0030 0.0555 0.0705)
+(0.0000 0.0555 0.0705)
+(0.0030 0.0555 0.0705)
+(0.0060 0.0555 0.0705)
+(-0.0060 0.0585 0.0705)
+(-0.0030 0.0585 0.0705)
+(0.0000 0.0585 0.0705)
+(0.0030 0.0585 0.0705)
+(0.0060 0.0585 0.0705)
+(-0.0060 0.0615 0.0705)
+(-0.0030 0.0615 0.0705)
+(0.0000 0.0615 0.0705)
+(0.0030 0.0615 0.0705)
+(0.0060 0.0615 0.0705)
+(-0.0060 0.0645 0.0705)
+(-0.0030 0.0645 0.0705)
+(0.0000 0.0645 0.0705)
+(0.0030 0.0645 0.0705)
+(0.0060 0.0645 0.0705)
+(-0.0060 0.0675 0.0705)
+(-0.0030 0.0675 0.0705)
+(0.0000 0.0675 0.0705)
+(0.0030 0.0675 0.0705)
+(0.0060 0.0675 0.0705)
+(-0.0060 0.0705 0.0705)
+(-0.0030 0.0705 0.0705)
+(0.0000 0.0705 0.0705)
+(0.0030 0.0705 0.0705)
+(0.0060 0.0705 0.0705)
+(-0.0060 0.0735 0.0705)
+(-0.0030 0.0735 0.0705)
+(0.0000 0.0735 0.0705)
+(0.0030 0.0735 0.0705)
+(0.0060 0.0735 0.0705)
+(-0.0060 -0.0735 0.0735)
+(-0.0030 -0.0735 0.0735)
+(0.0000 -0.0735 0.0735)
+(0.0030 -0.0735 0.0735)
+(0.0060 -0.0735 0.0735)
+(-0.0060 -0.0705 0.0735)
+(-0.0030 -0.0705 0.0735)
+(0.0000 -0.0705 0.0735)
+(0.0030 -0.0705 0.0735)
+(0.0060 -0.0705 0.0735)
+(-0.0060 -0.0675 0.0735)
+(-0.0030 -0.0675 0.0735)
+(0.0000 -0.0675 0.0735)
+(0.0030 -0.0675 0.0735)
+(0.0060 -0.0675 0.0735)
+(-0.0060 -0.0645 0.0735)
+(-0.0030 -0.0645 0.0735)
+(0.0000 -0.0645 0.0735)
+(0.0030 -0.0645 0.0735)
+(0.0060 -0.0645 0.0735)
+(-0.0060 -0.0615 0.0735)
+(-0.0030 -0.0615 0.0735)
+(0.0000 -0.0615 0.0735)
+(0.0030 -0.0615 0.0735)
+(0.0060 -0.0615 0.0735)
+(-0.0060 -0.0585 0.0735)
+(-0.0030 -0.0585 0.0735)
+(0.0000 -0.0585 0.0735)
+(0.0030 -0.0585 0.0735)
+(0.0060 -0.0585 0.0735)
+(-0.0060 -0.0555 0.0735)
+(-0.0030 -0.0555 0.0735)
+(0.0000 -0.0555 0.0735)
+(0.0030 -0.0555 0.0735)
+(0.0060 -0.0555 0.0735)
+(-0.0060 -0.0525 0.0735)
+(-0.0030 -0.0525 0.0735)
+(0.0000 -0.0525 0.0735)
+(0.0030 -0.0525 0.0735)
+(0.0060 -0.0525 0.0735)
+(-0.0060 -0.0495 0.0735)
+(-0.0030 -0.0495 0.0735)
+(0.0000 -0.0495 0.0735)
+(0.0030 -0.0495 0.0735)
+(0.0060 -0.0495 0.0735)
+(-0.0060 -0.0465 0.0735)
+(-0.0030 -0.0465 0.0735)
+(0.0000 -0.0465 0.0735)
+(0.0030 -0.0465 0.0735)
+(0.0060 -0.0465 0.0735)
+(-0.0060 -0.0435 0.0735)
+(-0.0030 -0.0435 0.0735)
+(0.0000 -0.0435 0.0735)
+(0.0030 -0.0435 0.0735)
+(0.0060 -0.0435 0.0735)
+(-0.0060 -0.0405 0.0735)
+(-0.0030 -0.0405 0.0735)
+(0.0000 -0.0405 0.0735)
+(0.0030 -0.0405 0.0735)
+(0.0060 -0.0405 0.0735)
+(-0.0060 -0.0375 0.0735)
+(-0.0030 -0.0375 0.0735)
+(0.0000 -0.0375 0.0735)
+(0.0030 -0.0375 0.0735)
+(0.0060 -0.0375 0.0735)
+(-0.0060 -0.0345 0.0735)
+(-0.0030 -0.0345 0.0735)
+(0.0000 -0.0345 0.0735)
+(0.0030 -0.0345 0.0735)
+(0.0060 -0.0345 0.0735)
+(-0.0060 -0.0315 0.0735)
+(-0.0030 -0.0315 0.0735)
+(0.0000 -0.0315 0.0735)
+(0.0030 -0.0315 0.0735)
+(0.0060 -0.0315 0.0735)
+(-0.0060 -0.0285 0.0735)
+(-0.0030 -0.0285 0.0735)
+(0.0000 -0.0285 0.0735)
+(0.0030 -0.0285 0.0735)
+(0.0060 -0.0285 0.0735)
+(-0.0060 -0.0255 0.0735)
+(-0.0030 -0.0255 0.0735)
+(0.0000 -0.0255 0.0735)
+(0.0030 -0.0255 0.0735)
+(0.0060 -0.0255 0.0735)
+(-0.0060 -0.0225 0.0735)
+(-0.0030 -0.0225 0.0735)
+(0.0000 -0.0225 0.0735)
+(0.0030 -0.0225 0.0735)
+(0.0060 -0.0225 0.0735)
+(-0.0060 -0.0195 0.0735)
+(-0.0030 -0.0195 0.0735)
+(0.0000 -0.0195 0.0735)
+(0.0030 -0.0195 0.0735)
+(0.0060 -0.0195 0.0735)
+(-0.0060 -0.0165 0.0735)
+(-0.0030 -0.0165 0.0735)
+(0.0000 -0.0165 0.0735)
+(0.0030 -0.0165 0.0735)
+(0.0060 -0.0165 0.0735)
+(-0.0060 -0.0135 0.0735)
+(-0.0030 -0.0135 0.0735)
+(0.0000 -0.0135 0.0735)
+(0.0030 -0.0135 0.0735)
+(0.0060 -0.0135 0.0735)
+(-0.0060 -0.0105 0.0735)
+(-0.0030 -0.0105 0.0735)
+(0.0000 -0.0105 0.0735)
+(0.0030 -0.0105 0.0735)
+(0.0060 -0.0105 0.0735)
+(-0.0060 -0.0075 0.0735)
+(-0.0030 -0.0075 0.0735)
+(0.0000 -0.0075 0.0735)
+(0.0030 -0.0075 0.0735)
+(0.0060 -0.0075 0.0735)
+(-0.0060 -0.0045 0.0735)
+(-0.0030 -0.0045 0.0735)
+(0.0000 -0.0045 0.0735)
+(0.0030 -0.0045 0.0735)
+(0.0060 -0.0045 0.0735)
+(-0.0060 -0.0015 0.0735)
+(-0.0030 -0.0015 0.0735)
+(0.0000 -0.0015 0.0735)
+(0.0030 -0.0015 0.0735)
+(0.0060 -0.0015 0.0735)
+(-0.0060 0.0015 0.0735)
+(-0.0030 0.0015 0.0735)
+(0.0000 0.0015 0.0735)
+(0.0030 0.0015 0.0735)
+(0.0060 0.0015 0.0735)
+(-0.0060 0.0045 0.0735)
+(-0.0030 0.0045 0.0735)
+(0.0000 0.0045 0.0735)
+(0.0030 0.0045 0.0735)
+(0.0060 0.0045 0.0735)
+(-0.0060 0.0075 0.0735)
+(-0.0030 0.0075 0.0735)
+(0.0000 0.0075 0.0735)
+(0.0030 0.0075 0.0735)
+(0.0060 0.0075 0.0735)
+(-0.0060 0.0105 0.0735)
+(-0.0030 0.0105 0.0735)
+(0.0000 0.0105 0.0735)
+(0.0030 0.0105 0.0735)
+(0.0060 0.0105 0.0735)
+(-0.0060 0.0135 0.0735)
+(-0.0030 0.0135 0.0735)
+(0.0000 0.0135 0.0735)
+(0.0030 0.0135 0.0735)
+(0.0060 0.0135 0.0735)
+(-0.0060 0.0165 0.0735)
+(-0.0030 0.0165 0.0735)
+(0.0000 0.0165 0.0735)
+(0.0030 0.0165 0.0735)
+(0.0060 0.0165 0.0735)
+(-0.0060 0.0195 0.0735)
+(-0.0030 0.0195 0.0735)
+(0.0000 0.0195 0.0735)
+(0.0030 0.0195 0.0735)
+(0.0060 0.0195 0.0735)
+(-0.0060 0.0225 0.0735)
+(-0.0030 0.0225 0.0735)
+(0.0000 0.0225 0.0735)
+(0.0030 0.0225 0.0735)
+(0.0060 0.0225 0.0735)
+(-0.0060 0.0255 0.0735)
+(-0.0030 0.0255 0.0735)
+(0.0000 0.0255 0.0735)
+(0.0030 0.0255 0.0735)
+(0.0060 0.0255 0.0735)
+(-0.0060 0.0285 0.0735)
+(-0.0030 0.0285 0.0735)
+(0.0000 0.0285 0.0735)
+(0.0030 0.0285 0.0735)
+(0.0060 0.0285 0.0735)
+(-0.0060 0.0315 0.0735)
+(-0.0030 0.0315 0.0735)
+(0.0000 0.0315 0.0735)
+(0.0030 0.0315 0.0735)
+(0.0060 0.0315 0.0735)
+(-0.0060 0.0345 0.0735)
+(-0.0030 0.0345 0.0735)
+(0.0000 0.0345 0.0735)
+(0.0030 0.0345 0.0735)
+(0.0060 0.0345 0.0735)
+(-0.0060 0.0375 0.0735)
+(-0.0030 0.0375 0.0735)
+(0.0000 0.0375 0.0735)
+(0.0030 0.0375 0.0735)
+(0.0060 0.0375 0.0735)
+(-0.0060 0.0405 0.0735)
+(-0.0030 0.0405 0.0735)
+(0.0000 0.0405 0.0735)
+(0.0030 0.0405 0.0735)
+(0.0060 0.0405 0.0735)
+(-0.0060 0.0435 0.0735)
+(-0.0030 0.0435 0.0735)
+(0.0000 0.0435 0.0735)
+(0.0030 0.0435 0.0735)
+(0.0060 0.0435 0.0735)
+(-0.0060 0.0465 0.0735)
+(-0.0030 0.0465 0.0735)
+(0.0000 0.0465 0.0735)
+(0.0030 0.0465 0.0735)
+(0.0060 0.0465 0.0735)
+(-0.0060 0.0495 0.0735)
+(-0.0030 0.0495 0.0735)
+(0.0000 0.0495 0.0735)
+(0.0030 0.0495 0.0735)
+(0.0060 0.0495 0.0735)
+(-0.0060 0.0525 0.0735)
+(-0.0030 0.0525 0.0735)
+(0.0000 0.0525 0.0735)
+(0.0030 0.0525 0.0735)
+(0.0060 0.0525 0.0735)
+(-0.0060 0.0555 0.0735)
+(-0.0030 0.0555 0.0735)
+(0.0000 0.0555 0.0735)
+(0.0030 0.0555 0.0735)
+(0.0060 0.0555 0.0735)
+(-0.0060 0.0585 0.0735)
+(-0.0030 0.0585 0.0735)
+(0.0000 0.0585 0.0735)
+(0.0030 0.0585 0.0735)
+(0.0060 0.0585 0.0735)
+(-0.0060 0.0615 0.0735)
+(-0.0030 0.0615 0.0735)
+(0.0000 0.0615 0.0735)
+(0.0030 0.0615 0.0735)
+(0.0060 0.0615 0.0735)
+(-0.0060 0.0645 0.0735)
+(-0.0030 0.0645 0.0735)
+(0.0000 0.0645 0.0735)
+(0.0030 0.0645 0.0735)
+(0.0060 0.0645 0.0735)
+(-0.0060 0.0675 0.0735)
+(-0.0030 0.0675 0.0735)
+(0.0000 0.0675 0.0735)
+(0.0030 0.0675 0.0735)
+(0.0060 0.0675 0.0735)
+(-0.0060 0.0705 0.0735)
+(-0.0030 0.0705 0.0735)
+(0.0000 0.0705 0.0735)
+(0.0030 0.0705 0.0735)
+(0.0060 0.0705 0.0735)
+(-0.0060 0.0735 0.0735)
+(-0.0030 0.0735 0.0735)
+(0.0000 0.0735 0.0735)
+(0.0030 0.0735 0.0735)
+(0.0060 0.0735 0.0735)
+(-0.0060 -0.0735 0.0765)
+(-0.0030 -0.0735 0.0765)
+(0.0000 -0.0735 0.0765)
+(0.0030 -0.0735 0.0765)
+(0.0060 -0.0735 0.0765)
+(-0.0060 -0.0705 0.0765)
+(-0.0030 -0.0705 0.0765)
+(0.0000 -0.0705 0.0765)
+(0.0030 -0.0705 0.0765)
+(0.0060 -0.0705 0.0765)
+(-0.0060 -0.0675 0.0765)
+(-0.0030 -0.0675 0.0765)
+(0.0000 -0.0675 0.0765)
+(0.0030 -0.0675 0.0765)
+(0.0060 -0.0675 0.0765)
+(-0.0060 -0.0645 0.0765)
+(-0.0030 -0.0645 0.0765)
+(0.0000 -0.0645 0.0765)
+(0.0030 -0.0645 0.0765)
+(0.0060 -0.0645 0.0765)
+(-0.0060 -0.0615 0.0765)
+(-0.0030 -0.0615 0.0765)
+(0.0000 -0.0615 0.0765)
+(0.0030 -0.0615 0.0765)
+(0.0060 -0.0615 0.0765)
+(-0.0060 -0.0585 0.0765)
+(-0.0030 -0.0585 0.0765)
+(0.0000 -0.0585 0.0765)
+(0.0030 -0.0585 0.0765)
+(0.0060 -0.0585 0.0765)
+(-0.0060 -0.0555 0.0765)
+(-0.0030 -0.0555 0.0765)
+(0.0000 -0.0555 0.0765)
+(0.0030 -0.0555 0.0765)
+(0.0060 -0.0555 0.0765)
+(-0.0060 -0.0525 0.0765)
+(-0.0030 -0.0525 0.0765)
+(0.0000 -0.0525 0.0765)
+(0.0030 -0.0525 0.0765)
+(0.0060 -0.0525 0.0765)
+(-0.0060 -0.0495 0.0765)
+(-0.0030 -0.0495 0.0765)
+(0.0000 -0.0495 0.0765)
+(0.0030 -0.0495 0.0765)
+(0.0060 -0.0495 0.0765)
+(-0.0060 -0.0465 0.0765)
+(-0.0030 -0.0465 0.0765)
+(0.0000 -0.0465 0.0765)
+(0.0030 -0.0465 0.0765)
+(0.0060 -0.0465 0.0765)
+(-0.0060 -0.0435 0.0765)
+(-0.0030 -0.0435 0.0765)
+(0.0000 -0.0435 0.0765)
+(0.0030 -0.0435 0.0765)
+(0.0060 -0.0435 0.0765)
+(-0.0060 -0.0405 0.0765)
+(-0.0030 -0.0405 0.0765)
+(0.0000 -0.0405 0.0765)
+(0.0030 -0.0405 0.0765)
+(0.0060 -0.0405 0.0765)
+(-0.0060 -0.0375 0.0765)
+(-0.0030 -0.0375 0.0765)
+(0.0000 -0.0375 0.0765)
+(0.0030 -0.0375 0.0765)
+(0.0060 -0.0375 0.0765)
+(-0.0060 -0.0345 0.0765)
+(-0.0030 -0.0345 0.0765)
+(0.0000 -0.0345 0.0765)
+(0.0030 -0.0345 0.0765)
+(0.0060 -0.0345 0.0765)
+(-0.0060 -0.0315 0.0765)
+(-0.0030 -0.0315 0.0765)
+(0.0000 -0.0315 0.0765)
+(0.0030 -0.0315 0.0765)
+(0.0060 -0.0315 0.0765)
+(-0.0060 -0.0285 0.0765)
+(-0.0030 -0.0285 0.0765)
+(0.0000 -0.0285 0.0765)
+(0.0030 -0.0285 0.0765)
+(0.0060 -0.0285 0.0765)
+(-0.0060 -0.0255 0.0765)
+(-0.0030 -0.0255 0.0765)
+(0.0000 -0.0255 0.0765)
+(0.0030 -0.0255 0.0765)
+(0.0060 -0.0255 0.0765)
+(-0.0060 -0.0225 0.0765)
+(-0.0030 -0.0225 0.0765)
+(0.0000 -0.0225 0.0765)
+(0.0030 -0.0225 0.0765)
+(0.0060 -0.0225 0.0765)
+(-0.0060 -0.0195 0.0765)
+(-0.0030 -0.0195 0.0765)
+(0.0000 -0.0195 0.0765)
+(0.0030 -0.0195 0.0765)
+(0.0060 -0.0195 0.0765)
+(-0.0060 -0.0165 0.0765)
+(-0.0030 -0.0165 0.0765)
+(0.0000 -0.0165 0.0765)
+(0.0030 -0.0165 0.0765)
+(0.0060 -0.0165 0.0765)
+(-0.0060 -0.0135 0.0765)
+(-0.0030 -0.0135 0.0765)
+(0.0000 -0.0135 0.0765)
+(0.0030 -0.0135 0.0765)
+(0.0060 -0.0135 0.0765)
+(-0.0060 -0.0105 0.0765)
+(-0.0030 -0.0105 0.0765)
+(0.0000 -0.0105 0.0765)
+(0.0030 -0.0105 0.0765)
+(0.0060 -0.0105 0.0765)
+(-0.0060 -0.0075 0.0765)
+(-0.0030 -0.0075 0.0765)
+(0.0000 -0.0075 0.0765)
+(0.0030 -0.0075 0.0765)
+(0.0060 -0.0075 0.0765)
+(-0.0060 -0.0045 0.0765)
+(-0.0030 -0.0045 0.0765)
+(0.0000 -0.0045 0.0765)
+(0.0030 -0.0045 0.0765)
+(0.0060 -0.0045 0.0765)
+(-0.0060 -0.0015 0.0765)
+(-0.0030 -0.0015 0.0765)
+(0.0000 -0.0015 0.0765)
+(0.0030 -0.0015 0.0765)
+(0.0060 -0.0015 0.0765)
+(-0.0060 0.0015 0.0765)
+(-0.0030 0.0015 0.0765)
+(0.0000 0.0015 0.0765)
+(0.0030 0.0015 0.0765)
+(0.0060 0.0015 0.0765)
+(-0.0060 0.0045 0.0765)
+(-0.0030 0.0045 0.0765)
+(0.0000 0.0045 0.0765)
+(0.0030 0.0045 0.0765)
+(0.0060 0.0045 0.0765)
+(-0.0060 0.0075 0.0765)
+(-0.0030 0.0075 0.0765)
+(0.0000 0.0075 0.0765)
+(0.0030 0.0075 0.0765)
+(0.0060 0.0075 0.0765)
+(-0.0060 0.0105 0.0765)
+(-0.0030 0.0105 0.0765)
+(0.0000 0.0105 0.0765)
+(0.0030 0.0105 0.0765)
+(0.0060 0.0105 0.0765)
+(-0.0060 0.0135 0.0765)
+(-0.0030 0.0135 0.0765)
+(0.0000 0.0135 0.0765)
+(0.0030 0.0135 0.0765)
+(0.0060 0.0135 0.0765)
+(-0.0060 0.0165 0.0765)
+(-0.0030 0.0165 0.0765)
+(0.0000 0.0165 0.0765)
+(0.0030 0.0165 0.0765)
+(0.0060 0.0165 0.0765)
+(-0.0060 0.0195 0.0765)
+(-0.0030 0.0195 0.0765)
+(0.0000 0.0195 0.0765)
+(0.0030 0.0195 0.0765)
+(0.0060 0.0195 0.0765)
+(-0.0060 0.0225 0.0765)
+(-0.0030 0.0225 0.0765)
+(0.0000 0.0225 0.0765)
+(0.0030 0.0225 0.0765)
+(0.0060 0.0225 0.0765)
+(-0.0060 0.0255 0.0765)
+(-0.0030 0.0255 0.0765)
+(0.0000 0.0255 0.0765)
+(0.0030 0.0255 0.0765)
+(0.0060 0.0255 0.0765)
+(-0.0060 0.0285 0.0765)
+(-0.0030 0.0285 0.0765)
+(0.0000 0.0285 0.0765)
+(0.0030 0.0285 0.0765)
+(0.0060 0.0285 0.0765)
+(-0.0060 0.0315 0.0765)
+(-0.0030 0.0315 0.0765)
+(0.0000 0.0315 0.0765)
+(0.0030 0.0315 0.0765)
+(0.0060 0.0315 0.0765)
+(-0.0060 0.0345 0.0765)
+(-0.0030 0.0345 0.0765)
+(0.0000 0.0345 0.0765)
+(0.0030 0.0345 0.0765)
+(0.0060 0.0345 0.0765)
+(-0.0060 0.0375 0.0765)
+(-0.0030 0.0375 0.0765)
+(0.0000 0.0375 0.0765)
+(0.0030 0.0375 0.0765)
+(0.0060 0.0375 0.0765)
+(-0.0060 0.0405 0.0765)
+(-0.0030 0.0405 0.0765)
+(0.0000 0.0405 0.0765)
+(0.0030 0.0405 0.0765)
+(0.0060 0.0405 0.0765)
+(-0.0060 0.0435 0.0765)
+(-0.0030 0.0435 0.0765)
+(0.0000 0.0435 0.0765)
+(0.0030 0.0435 0.0765)
+(0.0060 0.0435 0.0765)
+(-0.0060 0.0465 0.0765)
+(-0.0030 0.0465 0.0765)
+(0.0000 0.0465 0.0765)
+(0.0030 0.0465 0.0765)
+(0.0060 0.0465 0.0765)
+(-0.0060 0.0495 0.0765)
+(-0.0030 0.0495 0.0765)
+(0.0000 0.0495 0.0765)
+(0.0030 0.0495 0.0765)
+(0.0060 0.0495 0.0765)
+(-0.0060 0.0525 0.0765)
+(-0.0030 0.0525 0.0765)
+(0.0000 0.0525 0.0765)
+(0.0030 0.0525 0.0765)
+(0.0060 0.0525 0.0765)
+(-0.0060 0.0555 0.0765)
+(-0.0030 0.0555 0.0765)
+(0.0000 0.0555 0.0765)
+(0.0030 0.0555 0.0765)
+(0.0060 0.0555 0.0765)
+(-0.0060 0.0585 0.0765)
+(-0.0030 0.0585 0.0765)
+(0.0000 0.0585 0.0765)
+(0.0030 0.0585 0.0765)
+(0.0060 0.0585 0.0765)
+(-0.0060 0.0615 0.0765)
+(-0.0030 0.0615 0.0765)
+(0.0000 0.0615 0.0765)
+(0.0030 0.0615 0.0765)
+(0.0060 0.0615 0.0765)
+(-0.0060 0.0645 0.0765)
+(-0.0030 0.0645 0.0765)
+(0.0000 0.0645 0.0765)
+(0.0030 0.0645 0.0765)
+(0.0060 0.0645 0.0765)
+(-0.0060 0.0675 0.0765)
+(-0.0030 0.0675 0.0765)
+(0.0000 0.0675 0.0765)
+(0.0030 0.0675 0.0765)
+(0.0060 0.0675 0.0765)
+(-0.0060 0.0705 0.0765)
+(-0.0030 0.0705 0.0765)
+(0.0000 0.0705 0.0765)
+(0.0030 0.0705 0.0765)
+(0.0060 0.0705 0.0765)
+(-0.0060 0.0735 0.0765)
+(-0.0030 0.0735 0.0765)
+(0.0000 0.0735 0.0765)
+(0.0030 0.0735 0.0765)
+(0.0060 0.0735 0.0765)
+(-0.0060 -0.0735 0.0795)
+(-0.0030 -0.0735 0.0795)
+(0.0000 -0.0735 0.0795)
+(0.0030 -0.0735 0.0795)
+(0.0060 -0.0735 0.0795)
+(-0.0060 -0.0705 0.0795)
+(-0.0030 -0.0705 0.0795)
+(0.0000 -0.0705 0.0795)
+(0.0030 -0.0705 0.0795)
+(0.0060 -0.0705 0.0795)
+(-0.0060 -0.0675 0.0795)
+(-0.0030 -0.0675 0.0795)
+(0.0000 -0.0675 0.0795)
+(0.0030 -0.0675 0.0795)
+(0.0060 -0.0675 0.0795)
+(-0.0060 -0.0645 0.0795)
+(-0.0030 -0.0645 0.0795)
+(0.0000 -0.0645 0.0795)
+(0.0030 -0.0645 0.0795)
+(0.0060 -0.0645 0.0795)
+(-0.0060 -0.0615 0.0795)
+(-0.0030 -0.0615 0.0795)
+(0.0000 -0.0615 0.0795)
+(0.0030 -0.0615 0.0795)
+(0.0060 -0.0615 0.0795)
+(-0.0060 -0.0585 0.0795)
+(-0.0030 -0.0585 0.0795)
+(0.0000 -0.0585 0.0795)
+(0.0030 -0.0585 0.0795)
+(0.0060 -0.0585 0.0795)
+(-0.0060 -0.0555 0.0795)
+(-0.0030 -0.0555 0.0795)
+(0.0000 -0.0555 0.0795)
+(0.0030 -0.0555 0.0795)
+(0.0060 -0.0555 0.0795)
+(-0.0060 -0.0525 0.0795)
+(-0.0030 -0.0525 0.0795)
+(0.0000 -0.0525 0.0795)
+(0.0030 -0.0525 0.0795)
+(0.0060 -0.0525 0.0795)
+(-0.0060 -0.0495 0.0795)
+(-0.0030 -0.0495 0.0795)
+(0.0000 -0.0495 0.0795)
+(0.0030 -0.0495 0.0795)
+(0.0060 -0.0495 0.0795)
+(-0.0060 -0.0465 0.0795)
+(-0.0030 -0.0465 0.0795)
+(0.0000 -0.0465 0.0795)
+(0.0030 -0.0465 0.0795)
+(0.0060 -0.0465 0.0795)
+(-0.0060 -0.0435 0.0795)
+(-0.0030 -0.0435 0.0795)
+(0.0000 -0.0435 0.0795)
+(0.0030 -0.0435 0.0795)
+(0.0060 -0.0435 0.0795)
+(-0.0060 -0.0405 0.0795)
+(-0.0030 -0.0405 0.0795)
+(0.0000 -0.0405 0.0795)
+(0.0030 -0.0405 0.0795)
+(0.0060 -0.0405 0.0795)
+(-0.0060 -0.0375 0.0795)
+(-0.0030 -0.0375 0.0795)
+(0.0000 -0.0375 0.0795)
+(0.0030 -0.0375 0.0795)
+(0.0060 -0.0375 0.0795)
+(-0.0060 -0.0345 0.0795)
+(-0.0030 -0.0345 0.0795)
+(0.0000 -0.0345 0.0795)
+(0.0030 -0.0345 0.0795)
+(0.0060 -0.0345 0.0795)
+(-0.0060 -0.0315 0.0795)
+(-0.0030 -0.0315 0.0795)
+(0.0000 -0.0315 0.0795)
+(0.0030 -0.0315 0.0795)
+(0.0060 -0.0315 0.0795)
+(-0.0060 -0.0285 0.0795)
+(-0.0030 -0.0285 0.0795)
+(0.0000 -0.0285 0.0795)
+(0.0030 -0.0285 0.0795)
+(0.0060 -0.0285 0.0795)
+(-0.0060 -0.0255 0.0795)
+(-0.0030 -0.0255 0.0795)
+(0.0000 -0.0255 0.0795)
+(0.0030 -0.0255 0.0795)
+(0.0060 -0.0255 0.0795)
+(-0.0060 -0.0225 0.0795)
+(-0.0030 -0.0225 0.0795)
+(0.0000 -0.0225 0.0795)
+(0.0030 -0.0225 0.0795)
+(0.0060 -0.0225 0.0795)
+(-0.0060 -0.0195 0.0795)
+(-0.0030 -0.0195 0.0795)
+(0.0000 -0.0195 0.0795)
+(0.0030 -0.0195 0.0795)
+(0.0060 -0.0195 0.0795)
+(-0.0060 -0.0165 0.0795)
+(-0.0030 -0.0165 0.0795)
+(0.0000 -0.0165 0.0795)
+(0.0030 -0.0165 0.0795)
+(0.0060 -0.0165 0.0795)
+(-0.0060 -0.0135 0.0795)
+(-0.0030 -0.0135 0.0795)
+(0.0000 -0.0135 0.0795)
+(0.0030 -0.0135 0.0795)
+(0.0060 -0.0135 0.0795)
+(-0.0060 -0.0105 0.0795)
+(-0.0030 -0.0105 0.0795)
+(0.0000 -0.0105 0.0795)
+(0.0030 -0.0105 0.0795)
+(0.0060 -0.0105 0.0795)
+(-0.0060 -0.0075 0.0795)
+(-0.0030 -0.0075 0.0795)
+(0.0000 -0.0075 0.0795)
+(0.0030 -0.0075 0.0795)
+(0.0060 -0.0075 0.0795)
+(-0.0060 -0.0045 0.0795)
+(-0.0030 -0.0045 0.0795)
+(0.0000 -0.0045 0.0795)
+(0.0030 -0.0045 0.0795)
+(0.0060 -0.0045 0.0795)
+(-0.0060 -0.0015 0.0795)
+(-0.0030 -0.0015 0.0795)
+(0.0000 -0.0015 0.0795)
+(0.0030 -0.0015 0.0795)
+(0.0060 -0.0015 0.0795)
+(-0.0060 0.0015 0.0795)
+(-0.0030 0.0015 0.0795)
+(0.0000 0.0015 0.0795)
+(0.0030 0.0015 0.0795)
+(0.0060 0.0015 0.0795)
+(-0.0060 0.0045 0.0795)
+(-0.0030 0.0045 0.0795)
+(0.0000 0.0045 0.0795)
+(0.0030 0.0045 0.0795)
+(0.0060 0.0045 0.0795)
+(-0.0060 0.0075 0.0795)
+(-0.0030 0.0075 0.0795)
+(0.0000 0.0075 0.0795)
+(0.0030 0.0075 0.0795)
+(0.0060 0.0075 0.0795)
+(-0.0060 0.0105 0.0795)
+(-0.0030 0.0105 0.0795)
+(0.0000 0.0105 0.0795)
+(0.0030 0.0105 0.0795)
+(0.0060 0.0105 0.0795)
+(-0.0060 0.0135 0.0795)
+(-0.0030 0.0135 0.0795)
+(0.0000 0.0135 0.0795)
+(0.0030 0.0135 0.0795)
+(0.0060 0.0135 0.0795)
+(-0.0060 0.0165 0.0795)
+(-0.0030 0.0165 0.0795)
+(0.0000 0.0165 0.0795)
+(0.0030 0.0165 0.0795)
+(0.0060 0.0165 0.0795)
+(-0.0060 0.0195 0.0795)
+(-0.0030 0.0195 0.0795)
+(0.0000 0.0195 0.0795)
+(0.0030 0.0195 0.0795)
+(0.0060 0.0195 0.0795)
+(-0.0060 0.0225 0.0795)
+(-0.0030 0.0225 0.0795)
+(0.0000 0.0225 0.0795)
+(0.0030 0.0225 0.0795)
+(0.0060 0.0225 0.0795)
+(-0.0060 0.0255 0.0795)
+(-0.0030 0.0255 0.0795)
+(0.0000 0.0255 0.0795)
+(0.0030 0.0255 0.0795)
+(0.0060 0.0255 0.0795)
+(-0.0060 0.0285 0.0795)
+(-0.0030 0.0285 0.0795)
+(0.0000 0.0285 0.0795)
+(0.0030 0.0285 0.0795)
+(0.0060 0.0285 0.0795)
+(-0.0060 0.0315 0.0795)
+(-0.0030 0.0315 0.0795)
+(0.0000 0.0315 0.0795)
+(0.0030 0.0315 0.0795)
+(0.0060 0.0315 0.0795)
+(-0.0060 0.0345 0.0795)
+(-0.0030 0.0345 0.0795)
+(0.0000 0.0345 0.0795)
+(0.0030 0.0345 0.0795)
+(0.0060 0.0345 0.0795)
+(-0.0060 0.0375 0.0795)
+(-0.0030 0.0375 0.0795)
+(0.0000 0.0375 0.0795)
+(0.0030 0.0375 0.0795)
+(0.0060 0.0375 0.0795)
+(-0.0060 0.0405 0.0795)
+(-0.0030 0.0405 0.0795)
+(0.0000 0.0405 0.0795)
+(0.0030 0.0405 0.0795)
+(0.0060 0.0405 0.0795)
+(-0.0060 0.0435 0.0795)
+(-0.0030 0.0435 0.0795)
+(0.0000 0.0435 0.0795)
+(0.0030 0.0435 0.0795)
+(0.0060 0.0435 0.0795)
+(-0.0060 0.0465 0.0795)
+(-0.0030 0.0465 0.0795)
+(0.0000 0.0465 0.0795)
+(0.0030 0.0465 0.0795)
+(0.0060 0.0465 0.0795)
+(-0.0060 0.0495 0.0795)
+(-0.0030 0.0495 0.0795)
+(0.0000 0.0495 0.0795)
+(0.0030 0.0495 0.0795)
+(0.0060 0.0495 0.0795)
+(-0.0060 0.0525 0.0795)
+(-0.0030 0.0525 0.0795)
+(0.0000 0.0525 0.0795)
+(0.0030 0.0525 0.0795)
+(0.0060 0.0525 0.0795)
+(-0.0060 0.0555 0.0795)
+(-0.0030 0.0555 0.0795)
+(0.0000 0.0555 0.0795)
+(0.0030 0.0555 0.0795)
+(0.0060 0.0555 0.0795)
+(-0.0060 0.0585 0.0795)
+(-0.0030 0.0585 0.0795)
+(0.0000 0.0585 0.0795)
+(0.0030 0.0585 0.0795)
+(0.0060 0.0585 0.0795)
+(-0.0060 0.0615 0.0795)
+(-0.0030 0.0615 0.0795)
+(0.0000 0.0615 0.0795)
+(0.0030 0.0615 0.0795)
+(0.0060 0.0615 0.0795)
+(-0.0060 0.0645 0.0795)
+(-0.0030 0.0645 0.0795)
+(0.0000 0.0645 0.0795)
+(0.0030 0.0645 0.0795)
+(0.0060 0.0645 0.0795)
+(-0.0060 0.0675 0.0795)
+(-0.0030 0.0675 0.0795)
+(0.0000 0.0675 0.0795)
+(0.0030 0.0675 0.0795)
+(0.0060 0.0675 0.0795)
+(-0.0060 0.0705 0.0795)
+(-0.0030 0.0705 0.0795)
+(0.0000 0.0705 0.0795)
+(0.0030 0.0705 0.0795)
+(0.0060 0.0705 0.0795)
+(-0.0060 0.0735 0.0795)
+(-0.0030 0.0735 0.0795)
+(0.0000 0.0735 0.0795)
+(0.0030 0.0735 0.0795)
+(0.0060 0.0735 0.0795)
+(-0.0060 -0.0735 0.0825)
+(-0.0030 -0.0735 0.0825)
+(0.0000 -0.0735 0.0825)
+(0.0030 -0.0735 0.0825)
+(0.0060 -0.0735 0.0825)
+(-0.0060 -0.0705 0.0825)
+(-0.0030 -0.0705 0.0825)
+(0.0000 -0.0705 0.0825)
+(0.0030 -0.0705 0.0825)
+(0.0060 -0.0705 0.0825)
+(-0.0060 -0.0675 0.0825)
+(-0.0030 -0.0675 0.0825)
+(0.0000 -0.0675 0.0825)
+(0.0030 -0.0675 0.0825)
+(0.0060 -0.0675 0.0825)
+(-0.0060 -0.0645 0.0825)
+(-0.0030 -0.0645 0.0825)
+(0.0000 -0.0645 0.0825)
+(0.0030 -0.0645 0.0825)
+(0.0060 -0.0645 0.0825)
+(-0.0060 -0.0615 0.0825)
+(-0.0030 -0.0615 0.0825)
+(0.0000 -0.0615 0.0825)
+(0.0030 -0.0615 0.0825)
+(0.0060 -0.0615 0.0825)
+(-0.0060 -0.0585 0.0825)
+(-0.0030 -0.0585 0.0825)
+(0.0000 -0.0585 0.0825)
+(0.0030 -0.0585 0.0825)
+(0.0060 -0.0585 0.0825)
+(-0.0060 -0.0555 0.0825)
+(-0.0030 -0.0555 0.0825)
+(0.0000 -0.0555 0.0825)
+(0.0030 -0.0555 0.0825)
+(0.0060 -0.0555 0.0825)
+(-0.0060 -0.0525 0.0825)
+(-0.0030 -0.0525 0.0825)
+(0.0000 -0.0525 0.0825)
+(0.0030 -0.0525 0.0825)
+(0.0060 -0.0525 0.0825)
+(-0.0060 -0.0495 0.0825)
+(-0.0030 -0.0495 0.0825)
+(0.0000 -0.0495 0.0825)
+(0.0030 -0.0495 0.0825)
+(0.0060 -0.0495 0.0825)
+(-0.0060 -0.0465 0.0825)
+(-0.0030 -0.0465 0.0825)
+(0.0000 -0.0465 0.0825)
+(0.0030 -0.0465 0.0825)
+(0.0060 -0.0465 0.0825)
+(-0.0060 -0.0435 0.0825)
+(-0.0030 -0.0435 0.0825)
+(0.0000 -0.0435 0.0825)
+(0.0030 -0.0435 0.0825)
+(0.0060 -0.0435 0.0825)
+(-0.0060 -0.0405 0.0825)
+(-0.0030 -0.0405 0.0825)
+(0.0000 -0.0405 0.0825)
+(0.0030 -0.0405 0.0825)
+(0.0060 -0.0405 0.0825)
+(-0.0060 -0.0375 0.0825)
+(-0.0030 -0.0375 0.0825)
+(0.0000 -0.0375 0.0825)
+(0.0030 -0.0375 0.0825)
+(0.0060 -0.0375 0.0825)
+(-0.0060 -0.0345 0.0825)
+(-0.0030 -0.0345 0.0825)
+(0.0000 -0.0345 0.0825)
+(0.0030 -0.0345 0.0825)
+(0.0060 -0.0345 0.0825)
+(-0.0060 -0.0315 0.0825)
+(-0.0030 -0.0315 0.0825)
+(0.0000 -0.0315 0.0825)
+(0.0030 -0.0315 0.0825)
+(0.0060 -0.0315 0.0825)
+(-0.0060 -0.0285 0.0825)
+(-0.0030 -0.0285 0.0825)
+(0.0000 -0.0285 0.0825)
+(0.0030 -0.0285 0.0825)
+(0.0060 -0.0285 0.0825)
+(-0.0060 -0.0255 0.0825)
+(-0.0030 -0.0255 0.0825)
+(0.0000 -0.0255 0.0825)
+(0.0030 -0.0255 0.0825)
+(0.0060 -0.0255 0.0825)
+(-0.0060 -0.0225 0.0825)
+(-0.0030 -0.0225 0.0825)
+(0.0000 -0.0225 0.0825)
+(0.0030 -0.0225 0.0825)
+(0.0060 -0.0225 0.0825)
+(-0.0060 -0.0195 0.0825)
+(-0.0030 -0.0195 0.0825)
+(0.0000 -0.0195 0.0825)
+(0.0030 -0.0195 0.0825)
+(0.0060 -0.0195 0.0825)
+(-0.0060 -0.0165 0.0825)
+(-0.0030 -0.0165 0.0825)
+(0.0000 -0.0165 0.0825)
+(0.0030 -0.0165 0.0825)
+(0.0060 -0.0165 0.0825)
+(-0.0060 -0.0135 0.0825)
+(-0.0030 -0.0135 0.0825)
+(0.0000 -0.0135 0.0825)
+(0.0030 -0.0135 0.0825)
+(0.0060 -0.0135 0.0825)
+(-0.0060 -0.0105 0.0825)
+(-0.0030 -0.0105 0.0825)
+(0.0000 -0.0105 0.0825)
+(0.0030 -0.0105 0.0825)
+(0.0060 -0.0105 0.0825)
+(-0.0060 -0.0075 0.0825)
+(-0.0030 -0.0075 0.0825)
+(0.0000 -0.0075 0.0825)
+(0.0030 -0.0075 0.0825)
+(0.0060 -0.0075 0.0825)
+(-0.0060 -0.0045 0.0825)
+(-0.0030 -0.0045 0.0825)
+(0.0000 -0.0045 0.0825)
+(0.0030 -0.0045 0.0825)
+(0.0060 -0.0045 0.0825)
+(-0.0060 -0.0015 0.0825)
+(-0.0030 -0.0015 0.0825)
+(0.0000 -0.0015 0.0825)
+(0.0030 -0.0015 0.0825)
+(0.0060 -0.0015 0.0825)
+(-0.0060 0.0015 0.0825)
+(-0.0030 0.0015 0.0825)
+(0.0000 0.0015 0.0825)
+(0.0030 0.0015 0.0825)
+(0.0060 0.0015 0.0825)
+(-0.0060 0.0045 0.0825)
+(-0.0030 0.0045 0.0825)
+(0.0000 0.0045 0.0825)
+(0.0030 0.0045 0.0825)
+(0.0060 0.0045 0.0825)
+(-0.0060 0.0075 0.0825)
+(-0.0030 0.0075 0.0825)
+(0.0000 0.0075 0.0825)
+(0.0030 0.0075 0.0825)
+(0.0060 0.0075 0.0825)
+(-0.0060 0.0105 0.0825)
+(-0.0030 0.0105 0.0825)
+(0.0000 0.0105 0.0825)
+(0.0030 0.0105 0.0825)
+(0.0060 0.0105 0.0825)
+(-0.0060 0.0135 0.0825)
+(-0.0030 0.0135 0.0825)
+(0.0000 0.0135 0.0825)
+(0.0030 0.0135 0.0825)
+(0.0060 0.0135 0.0825)
+(-0.0060 0.0165 0.0825)
+(-0.0030 0.0165 0.0825)
+(0.0000 0.0165 0.0825)
+(0.0030 0.0165 0.0825)
+(0.0060 0.0165 0.0825)
+(-0.0060 0.0195 0.0825)
+(-0.0030 0.0195 0.0825)
+(0.0000 0.0195 0.0825)
+(0.0030 0.0195 0.0825)
+(0.0060 0.0195 0.0825)
+(-0.0060 0.0225 0.0825)
+(-0.0030 0.0225 0.0825)
+(0.0000 0.0225 0.0825)
+(0.0030 0.0225 0.0825)
+(0.0060 0.0225 0.0825)
+(-0.0060 0.0255 0.0825)
+(-0.0030 0.0255 0.0825)
+(0.0000 0.0255 0.0825)
+(0.0030 0.0255 0.0825)
+(0.0060 0.0255 0.0825)
+(-0.0060 0.0285 0.0825)
+(-0.0030 0.0285 0.0825)
+(0.0000 0.0285 0.0825)
+(0.0030 0.0285 0.0825)
+(0.0060 0.0285 0.0825)
+(-0.0060 0.0315 0.0825)
+(-0.0030 0.0315 0.0825)
+(0.0000 0.0315 0.0825)
+(0.0030 0.0315 0.0825)
+(0.0060 0.0315 0.0825)
+(-0.0060 0.0345 0.0825)
+(-0.0030 0.0345 0.0825)
+(0.0000 0.0345 0.0825)
+(0.0030 0.0345 0.0825)
+(0.0060 0.0345 0.0825)
+(-0.0060 0.0375 0.0825)
+(-0.0030 0.0375 0.0825)
+(0.0000 0.0375 0.0825)
+(0.0030 0.0375 0.0825)
+(0.0060 0.0375 0.0825)
+(-0.0060 0.0405 0.0825)
+(-0.0030 0.0405 0.0825)
+(0.0000 0.0405 0.0825)
+(0.0030 0.0405 0.0825)
+(0.0060 0.0405 0.0825)
+(-0.0060 0.0435 0.0825)
+(-0.0030 0.0435 0.0825)
+(0.0000 0.0435 0.0825)
+(0.0030 0.0435 0.0825)
+(0.0060 0.0435 0.0825)
+(-0.0060 0.0465 0.0825)
+(-0.0030 0.0465 0.0825)
+(0.0000 0.0465 0.0825)
+(0.0030 0.0465 0.0825)
+(0.0060 0.0465 0.0825)
+(-0.0060 0.0495 0.0825)
+(-0.0030 0.0495 0.0825)
+(0.0000 0.0495 0.0825)
+(0.0030 0.0495 0.0825)
+(0.0060 0.0495 0.0825)
+(-0.0060 0.0525 0.0825)
+(-0.0030 0.0525 0.0825)
+(0.0000 0.0525 0.0825)
+(0.0030 0.0525 0.0825)
+(0.0060 0.0525 0.0825)
+(-0.0060 0.0555 0.0825)
+(-0.0030 0.0555 0.0825)
+(0.0000 0.0555 0.0825)
+(0.0030 0.0555 0.0825)
+(0.0060 0.0555 0.0825)
+(-0.0060 0.0585 0.0825)
+(-0.0030 0.0585 0.0825)
+(0.0000 0.0585 0.0825)
+(0.0030 0.0585 0.0825)
+(0.0060 0.0585 0.0825)
+(-0.0060 0.0615 0.0825)
+(-0.0030 0.0615 0.0825)
+(0.0000 0.0615 0.0825)
+(0.0030 0.0615 0.0825)
+(0.0060 0.0615 0.0825)
+(-0.0060 0.0645 0.0825)
+(-0.0030 0.0645 0.0825)
+(0.0000 0.0645 0.0825)
+(0.0030 0.0645 0.0825)
+(0.0060 0.0645 0.0825)
+(-0.0060 0.0675 0.0825)
+(-0.0030 0.0675 0.0825)
+(0.0000 0.0675 0.0825)
+(0.0030 0.0675 0.0825)
+(0.0060 0.0675 0.0825)
+(-0.0060 0.0705 0.0825)
+(-0.0030 0.0705 0.0825)
+(0.0000 0.0705 0.0825)
+(0.0030 0.0705 0.0825)
+(0.0060 0.0705 0.0825)
+(-0.0060 0.0735 0.0825)
+(-0.0030 0.0735 0.0825)
+(0.0000 0.0735 0.0825)
+(0.0030 0.0735 0.0825)
+(0.0060 0.0735 0.0825)
+(-0.0060 -0.0735 0.0855)
+(-0.0030 -0.0735 0.0855)
+(0.0000 -0.0735 0.0855)
+(0.0030 -0.0735 0.0855)
+(0.0060 -0.0735 0.0855)
+(-0.0060 -0.0705 0.0855)
+(-0.0030 -0.0705 0.0855)
+(0.0000 -0.0705 0.0855)
+(0.0030 -0.0705 0.0855)
+(0.0060 -0.0705 0.0855)
+(-0.0060 -0.0675 0.0855)
+(-0.0030 -0.0675 0.0855)
+(0.0000 -0.0675 0.0855)
+(0.0030 -0.0675 0.0855)
+(0.0060 -0.0675 0.0855)
+(-0.0060 -0.0645 0.0855)
+(-0.0030 -0.0645 0.0855)
+(0.0000 -0.0645 0.0855)
+(0.0030 -0.0645 0.0855)
+(0.0060 -0.0645 0.0855)
+(-0.0060 -0.0615 0.0855)
+(-0.0030 -0.0615 0.0855)
+(0.0000 -0.0615 0.0855)
+(0.0030 -0.0615 0.0855)
+(0.0060 -0.0615 0.0855)
+(-0.0060 -0.0585 0.0855)
+(-0.0030 -0.0585 0.0855)
+(0.0000 -0.0585 0.0855)
+(0.0030 -0.0585 0.0855)
+(0.0060 -0.0585 0.0855)
+(-0.0060 -0.0555 0.0855)
+(-0.0030 -0.0555 0.0855)
+(0.0000 -0.0555 0.0855)
+(0.0030 -0.0555 0.0855)
+(0.0060 -0.0555 0.0855)
+(-0.0060 -0.0525 0.0855)
+(-0.0030 -0.0525 0.0855)
+(0.0000 -0.0525 0.0855)
+(0.0030 -0.0525 0.0855)
+(0.0060 -0.0525 0.0855)
+(-0.0060 -0.0495 0.0855)
+(-0.0030 -0.0495 0.0855)
+(0.0000 -0.0495 0.0855)
+(0.0030 -0.0495 0.0855)
+(0.0060 -0.0495 0.0855)
+(-0.0060 -0.0465 0.0855)
+(-0.0030 -0.0465 0.0855)
+(0.0000 -0.0465 0.0855)
+(0.0030 -0.0465 0.0855)
+(0.0060 -0.0465 0.0855)
+(-0.0060 -0.0435 0.0855)
+(-0.0030 -0.0435 0.0855)
+(0.0000 -0.0435 0.0855)
+(0.0030 -0.0435 0.0855)
+(0.0060 -0.0435 0.0855)
+(-0.0060 -0.0405 0.0855)
+(-0.0030 -0.0405 0.0855)
+(0.0000 -0.0405 0.0855)
+(0.0030 -0.0405 0.0855)
+(0.0060 -0.0405 0.0855)
+(-0.0060 -0.0375 0.0855)
+(-0.0030 -0.0375 0.0855)
+(0.0000 -0.0375 0.0855)
+(0.0030 -0.0375 0.0855)
+(0.0060 -0.0375 0.0855)
+(-0.0060 -0.0345 0.0855)
+(-0.0030 -0.0345 0.0855)
+(0.0000 -0.0345 0.0855)
+(0.0030 -0.0345 0.0855)
+(0.0060 -0.0345 0.0855)
+(-0.0060 -0.0315 0.0855)
+(-0.0030 -0.0315 0.0855)
+(0.0000 -0.0315 0.0855)
+(0.0030 -0.0315 0.0855)
+(0.0060 -0.0315 0.0855)
+(-0.0060 -0.0285 0.0855)
+(-0.0030 -0.0285 0.0855)
+(0.0000 -0.0285 0.0855)
+(0.0030 -0.0285 0.0855)
+(0.0060 -0.0285 0.0855)
+(-0.0060 -0.0255 0.0855)
+(-0.0030 -0.0255 0.0855)
+(0.0000 -0.0255 0.0855)
+(0.0030 -0.0255 0.0855)
+(0.0060 -0.0255 0.0855)
+(-0.0060 -0.0225 0.0855)
+(-0.0030 -0.0225 0.0855)
+(0.0000 -0.0225 0.0855)
+(0.0030 -0.0225 0.0855)
+(0.0060 -0.0225 0.0855)
+(-0.0060 -0.0195 0.0855)
+(-0.0030 -0.0195 0.0855)
+(0.0000 -0.0195 0.0855)
+(0.0030 -0.0195 0.0855)
+(0.0060 -0.0195 0.0855)
+(-0.0060 -0.0165 0.0855)
+(-0.0030 -0.0165 0.0855)
+(0.0000 -0.0165 0.0855)
+(0.0030 -0.0165 0.0855)
+(0.0060 -0.0165 0.0855)
+(-0.0060 -0.0135 0.0855)
+(-0.0030 -0.0135 0.0855)
+(0.0000 -0.0135 0.0855)
+(0.0030 -0.0135 0.0855)
+(0.0060 -0.0135 0.0855)
+(-0.0060 -0.0105 0.0855)
+(-0.0030 -0.0105 0.0855)
+(0.0000 -0.0105 0.0855)
+(0.0030 -0.0105 0.0855)
+(0.0060 -0.0105 0.0855)
+(-0.0060 -0.0075 0.0855)
+(-0.0030 -0.0075 0.0855)
+(0.0000 -0.0075 0.0855)
+(0.0030 -0.0075 0.0855)
+(0.0060 -0.0075 0.0855)
+(-0.0060 -0.0045 0.0855)
+(-0.0030 -0.0045 0.0855)
+(0.0000 -0.0045 0.0855)
+(0.0030 -0.0045 0.0855)
+(0.0060 -0.0045 0.0855)
+(-0.0060 -0.0015 0.0855)
+(-0.0030 -0.0015 0.0855)
+(0.0000 -0.0015 0.0855)
+(0.0030 -0.0015 0.0855)
+(0.0060 -0.0015 0.0855)
+(-0.0060 0.0015 0.0855)
+(-0.0030 0.0015 0.0855)
+(0.0000 0.0015 0.0855)
+(0.0030 0.0015 0.0855)
+(0.0060 0.0015 0.0855)
+(-0.0060 0.0045 0.0855)
+(-0.0030 0.0045 0.0855)
+(0.0000 0.0045 0.0855)
+(0.0030 0.0045 0.0855)
+(0.0060 0.0045 0.0855)
+(-0.0060 0.0075 0.0855)
+(-0.0030 0.0075 0.0855)
+(0.0000 0.0075 0.0855)
+(0.0030 0.0075 0.0855)
+(0.0060 0.0075 0.0855)
+(-0.0060 0.0105 0.0855)
+(-0.0030 0.0105 0.0855)
+(0.0000 0.0105 0.0855)
+(0.0030 0.0105 0.0855)
+(0.0060 0.0105 0.0855)
+(-0.0060 0.0135 0.0855)
+(-0.0030 0.0135 0.0855)
+(0.0000 0.0135 0.0855)
+(0.0030 0.0135 0.0855)
+(0.0060 0.0135 0.0855)
+(-0.0060 0.0165 0.0855)
+(-0.0030 0.0165 0.0855)
+(0.0000 0.0165 0.0855)
+(0.0030 0.0165 0.0855)
+(0.0060 0.0165 0.0855)
+(-0.0060 0.0195 0.0855)
+(-0.0030 0.0195 0.0855)
+(0.0000 0.0195 0.0855)
+(0.0030 0.0195 0.0855)
+(0.0060 0.0195 0.0855)
+(-0.0060 0.0225 0.0855)
+(-0.0030 0.0225 0.0855)
+(0.0000 0.0225 0.0855)
+(0.0030 0.0225 0.0855)
+(0.0060 0.0225 0.0855)
+(-0.0060 0.0255 0.0855)
+(-0.0030 0.0255 0.0855)
+(0.0000 0.0255 0.0855)
+(0.0030 0.0255 0.0855)
+(0.0060 0.0255 0.0855)
+(-0.0060 0.0285 0.0855)
+(-0.0030 0.0285 0.0855)
+(0.0000 0.0285 0.0855)
+(0.0030 0.0285 0.0855)
+(0.0060 0.0285 0.0855)
+(-0.0060 0.0315 0.0855)
+(-0.0030 0.0315 0.0855)
+(0.0000 0.0315 0.0855)
+(0.0030 0.0315 0.0855)
+(0.0060 0.0315 0.0855)
+(-0.0060 0.0345 0.0855)
+(-0.0030 0.0345 0.0855)
+(0.0000 0.0345 0.0855)
+(0.0030 0.0345 0.0855)
+(0.0060 0.0345 0.0855)
+(-0.0060 0.0375 0.0855)
+(-0.0030 0.0375 0.0855)
+(0.0000 0.0375 0.0855)
+(0.0030 0.0375 0.0855)
+(0.0060 0.0375 0.0855)
+(-0.0060 0.0405 0.0855)
+(-0.0030 0.0405 0.0855)
+(0.0000 0.0405 0.0855)
+(0.0030 0.0405 0.0855)
+(0.0060 0.0405 0.0855)
+(-0.0060 0.0435 0.0855)
+(-0.0030 0.0435 0.0855)
+(0.0000 0.0435 0.0855)
+(0.0030 0.0435 0.0855)
+(0.0060 0.0435 0.0855)
+(-0.0060 0.0465 0.0855)
+(-0.0030 0.0465 0.0855)
+(0.0000 0.0465 0.0855)
+(0.0030 0.0465 0.0855)
+(0.0060 0.0465 0.0855)
+(-0.0060 0.0495 0.0855)
+(-0.0030 0.0495 0.0855)
+(0.0000 0.0495 0.0855)
+(0.0030 0.0495 0.0855)
+(0.0060 0.0495 0.0855)
+(-0.0060 0.0525 0.0855)
+(-0.0030 0.0525 0.0855)
+(0.0000 0.0525 0.0855)
+(0.0030 0.0525 0.0855)
+(0.0060 0.0525 0.0855)
+(-0.0060 0.0555 0.0855)
+(-0.0030 0.0555 0.0855)
+(0.0000 0.0555 0.0855)
+(0.0030 0.0555 0.0855)
+(0.0060 0.0555 0.0855)
+(-0.0060 0.0585 0.0855)
+(-0.0030 0.0585 0.0855)
+(0.0000 0.0585 0.0855)
+(0.0030 0.0585 0.0855)
+(0.0060 0.0585 0.0855)
+(-0.0060 0.0615 0.0855)
+(-0.0030 0.0615 0.0855)
+(0.0000 0.0615 0.0855)
+(0.0030 0.0615 0.0855)
+(0.0060 0.0615 0.0855)
+(-0.0060 0.0645 0.0855)
+(-0.0030 0.0645 0.0855)
+(0.0000 0.0645 0.0855)
+(0.0030 0.0645 0.0855)
+(0.0060 0.0645 0.0855)
+(-0.0060 0.0675 0.0855)
+(-0.0030 0.0675 0.0855)
+(0.0000 0.0675 0.0855)
+(0.0030 0.0675 0.0855)
+(0.0060 0.0675 0.0855)
+(-0.0060 0.0705 0.0855)
+(-0.0030 0.0705 0.0855)
+(0.0000 0.0705 0.0855)
+(0.0030 0.0705 0.0855)
+(0.0060 0.0705 0.0855)
+(-0.0060 0.0735 0.0855)
+(-0.0030 0.0735 0.0855)
+(0.0000 0.0735 0.0855)
+(0.0030 0.0735 0.0855)
+(0.0060 0.0735 0.0855)
+(-0.0060 -0.0735 0.0885)
+(-0.0030 -0.0735 0.0885)
+(0.0000 -0.0735 0.0885)
+(0.0030 -0.0735 0.0885)
+(0.0060 -0.0735 0.0885)
+(-0.0060 -0.0705 0.0885)
+(-0.0030 -0.0705 0.0885)
+(0.0000 -0.0705 0.0885)
+(0.0030 -0.0705 0.0885)
+(0.0060 -0.0705 0.0885)
+(-0.0060 -0.0675 0.0885)
+(-0.0030 -0.0675 0.0885)
+(0.0000 -0.0675 0.0885)
+(0.0030 -0.0675 0.0885)
+(0.0060 -0.0675 0.0885)
+(-0.0060 -0.0645 0.0885)
+(-0.0030 -0.0645 0.0885)
+(0.0000 -0.0645 0.0885)
+(0.0030 -0.0645 0.0885)
+(0.0060 -0.0645 0.0885)
+(-0.0060 -0.0615 0.0885)
+(-0.0030 -0.0615 0.0885)
+(0.0000 -0.0615 0.0885)
+(0.0030 -0.0615 0.0885)
+(0.0060 -0.0615 0.0885)
+(-0.0060 -0.0585 0.0885)
+(-0.0030 -0.0585 0.0885)
+(0.0000 -0.0585 0.0885)
+(0.0030 -0.0585 0.0885)
+(0.0060 -0.0585 0.0885)
+(-0.0060 -0.0555 0.0885)
+(-0.0030 -0.0555 0.0885)
+(0.0000 -0.0555 0.0885)
+(0.0030 -0.0555 0.0885)
+(0.0060 -0.0555 0.0885)
+(-0.0060 -0.0525 0.0885)
+(-0.0030 -0.0525 0.0885)
+(0.0000 -0.0525 0.0885)
+(0.0030 -0.0525 0.0885)
+(0.0060 -0.0525 0.0885)
+(-0.0060 -0.0495 0.0885)
+(-0.0030 -0.0495 0.0885)
+(0.0000 -0.0495 0.0885)
+(0.0030 -0.0495 0.0885)
+(0.0060 -0.0495 0.0885)
+(-0.0060 -0.0465 0.0885)
+(-0.0030 -0.0465 0.0885)
+(0.0000 -0.0465 0.0885)
+(0.0030 -0.0465 0.0885)
+(0.0060 -0.0465 0.0885)
+(-0.0060 -0.0435 0.0885)
+(-0.0030 -0.0435 0.0885)
+(0.0000 -0.0435 0.0885)
+(0.0030 -0.0435 0.0885)
+(0.0060 -0.0435 0.0885)
+(-0.0060 -0.0405 0.0885)
+(-0.0030 -0.0405 0.0885)
+(0.0000 -0.0405 0.0885)
+(0.0030 -0.0405 0.0885)
+(0.0060 -0.0405 0.0885)
+(-0.0060 -0.0375 0.0885)
+(-0.0030 -0.0375 0.0885)
+(0.0000 -0.0375 0.0885)
+(0.0030 -0.0375 0.0885)
+(0.0060 -0.0375 0.0885)
+(-0.0060 -0.0345 0.0885)
+(-0.0030 -0.0345 0.0885)
+(0.0000 -0.0345 0.0885)
+(0.0030 -0.0345 0.0885)
+(0.0060 -0.0345 0.0885)
+(-0.0060 -0.0315 0.0885)
+(-0.0030 -0.0315 0.0885)
+(0.0000 -0.0315 0.0885)
+(0.0030 -0.0315 0.0885)
+(0.0060 -0.0315 0.0885)
+(-0.0060 -0.0285 0.0885)
+(-0.0030 -0.0285 0.0885)
+(0.0000 -0.0285 0.0885)
+(0.0030 -0.0285 0.0885)
+(0.0060 -0.0285 0.0885)
+(-0.0060 -0.0255 0.0885)
+(-0.0030 -0.0255 0.0885)
+(0.0000 -0.0255 0.0885)
+(0.0030 -0.0255 0.0885)
+(0.0060 -0.0255 0.0885)
+(-0.0060 -0.0225 0.0885)
+(-0.0030 -0.0225 0.0885)
+(0.0000 -0.0225 0.0885)
+(0.0030 -0.0225 0.0885)
+(0.0060 -0.0225 0.0885)
+(-0.0060 -0.0195 0.0885)
+(-0.0030 -0.0195 0.0885)
+(0.0000 -0.0195 0.0885)
+(0.0030 -0.0195 0.0885)
+(0.0060 -0.0195 0.0885)
+(-0.0060 -0.0165 0.0885)
+(-0.0030 -0.0165 0.0885)
+(0.0000 -0.0165 0.0885)
+(0.0030 -0.0165 0.0885)
+(0.0060 -0.0165 0.0885)
+(-0.0060 -0.0135 0.0885)
+(-0.0030 -0.0135 0.0885)
+(0.0000 -0.0135 0.0885)
+(0.0030 -0.0135 0.0885)
+(0.0060 -0.0135 0.0885)
+(-0.0060 -0.0105 0.0885)
+(-0.0030 -0.0105 0.0885)
+(0.0000 -0.0105 0.0885)
+(0.0030 -0.0105 0.0885)
+(0.0060 -0.0105 0.0885)
+(-0.0060 -0.0075 0.0885)
+(-0.0030 -0.0075 0.0885)
+(0.0000 -0.0075 0.0885)
+(0.0030 -0.0075 0.0885)
+(0.0060 -0.0075 0.0885)
+(-0.0060 -0.0045 0.0885)
+(-0.0030 -0.0045 0.0885)
+(0.0000 -0.0045 0.0885)
+(0.0030 -0.0045 0.0885)
+(0.0060 -0.0045 0.0885)
+(-0.0060 -0.0015 0.0885)
+(-0.0030 -0.0015 0.0885)
+(0.0000 -0.0015 0.0885)
+(0.0030 -0.0015 0.0885)
+(0.0060 -0.0015 0.0885)
+(-0.0060 0.0015 0.0885)
+(-0.0030 0.0015 0.0885)
+(0.0000 0.0015 0.0885)
+(0.0030 0.0015 0.0885)
+(0.0060 0.0015 0.0885)
+(-0.0060 0.0045 0.0885)
+(-0.0030 0.0045 0.0885)
+(0.0000 0.0045 0.0885)
+(0.0030 0.0045 0.0885)
+(0.0060 0.0045 0.0885)
+(-0.0060 0.0075 0.0885)
+(-0.0030 0.0075 0.0885)
+(0.0000 0.0075 0.0885)
+(0.0030 0.0075 0.0885)
+(0.0060 0.0075 0.0885)
+(-0.0060 0.0105 0.0885)
+(-0.0030 0.0105 0.0885)
+(0.0000 0.0105 0.0885)
+(0.0030 0.0105 0.0885)
+(0.0060 0.0105 0.0885)
+(-0.0060 0.0135 0.0885)
+(-0.0030 0.0135 0.0885)
+(0.0000 0.0135 0.0885)
+(0.0030 0.0135 0.0885)
+(0.0060 0.0135 0.0885)
+(-0.0060 0.0165 0.0885)
+(-0.0030 0.0165 0.0885)
+(0.0000 0.0165 0.0885)
+(0.0030 0.0165 0.0885)
+(0.0060 0.0165 0.0885)
+(-0.0060 0.0195 0.0885)
+(-0.0030 0.0195 0.0885)
+(0.0000 0.0195 0.0885)
+(0.0030 0.0195 0.0885)
+(0.0060 0.0195 0.0885)
+(-0.0060 0.0225 0.0885)
+(-0.0030 0.0225 0.0885)
+(0.0000 0.0225 0.0885)
+(0.0030 0.0225 0.0885)
+(0.0060 0.0225 0.0885)
+(-0.0060 0.0255 0.0885)
+(-0.0030 0.0255 0.0885)
+(0.0000 0.0255 0.0885)
+(0.0030 0.0255 0.0885)
+(0.0060 0.0255 0.0885)
+(-0.0060 0.0285 0.0885)
+(-0.0030 0.0285 0.0885)
+(0.0000 0.0285 0.0885)
+(0.0030 0.0285 0.0885)
+(0.0060 0.0285 0.0885)
+(-0.0060 0.0315 0.0885)
+(-0.0030 0.0315 0.0885)
+(0.0000 0.0315 0.0885)
+(0.0030 0.0315 0.0885)
+(0.0060 0.0315 0.0885)
+(-0.0060 0.0345 0.0885)
+(-0.0030 0.0345 0.0885)
+(0.0000 0.0345 0.0885)
+(0.0030 0.0345 0.0885)
+(0.0060 0.0345 0.0885)
+(-0.0060 0.0375 0.0885)
+(-0.0030 0.0375 0.0885)
+(0.0000 0.0375 0.0885)
+(0.0030 0.0375 0.0885)
+(0.0060 0.0375 0.0885)
+(-0.0060 0.0405 0.0885)
+(-0.0030 0.0405 0.0885)
+(0.0000 0.0405 0.0885)
+(0.0030 0.0405 0.0885)
+(0.0060 0.0405 0.0885)
+(-0.0060 0.0435 0.0885)
+(-0.0030 0.0435 0.0885)
+(0.0000 0.0435 0.0885)
+(0.0030 0.0435 0.0885)
+(0.0060 0.0435 0.0885)
+(-0.0060 0.0465 0.0885)
+(-0.0030 0.0465 0.0885)
+(0.0000 0.0465 0.0885)
+(0.0030 0.0465 0.0885)
+(0.0060 0.0465 0.0885)
+(-0.0060 0.0495 0.0885)
+(-0.0030 0.0495 0.0885)
+(0.0000 0.0495 0.0885)
+(0.0030 0.0495 0.0885)
+(0.0060 0.0495 0.0885)
+(-0.0060 0.0525 0.0885)
+(-0.0030 0.0525 0.0885)
+(0.0000 0.0525 0.0885)
+(0.0030 0.0525 0.0885)
+(0.0060 0.0525 0.0885)
+(-0.0060 0.0555 0.0885)
+(-0.0030 0.0555 0.0885)
+(0.0000 0.0555 0.0885)
+(0.0030 0.0555 0.0885)
+(0.0060 0.0555 0.0885)
+(-0.0060 0.0585 0.0885)
+(-0.0030 0.0585 0.0885)
+(0.0000 0.0585 0.0885)
+(0.0030 0.0585 0.0885)
+(0.0060 0.0585 0.0885)
+(-0.0060 0.0615 0.0885)
+(-0.0030 0.0615 0.0885)
+(0.0000 0.0615 0.0885)
+(0.0030 0.0615 0.0885)
+(0.0060 0.0615 0.0885)
+(-0.0060 0.0645 0.0885)
+(-0.0030 0.0645 0.0885)
+(0.0000 0.0645 0.0885)
+(0.0030 0.0645 0.0885)
+(0.0060 0.0645 0.0885)
+(-0.0060 0.0675 0.0885)
+(-0.0030 0.0675 0.0885)
+(0.0000 0.0675 0.0885)
+(0.0030 0.0675 0.0885)
+(0.0060 0.0675 0.0885)
+(-0.0060 0.0705 0.0885)
+(-0.0030 0.0705 0.0885)
+(0.0000 0.0705 0.0885)
+(0.0030 0.0705 0.0885)
+(0.0060 0.0705 0.0885)
+(-0.0060 0.0735 0.0885)
+(-0.0030 0.0735 0.0885)
+(0.0000 0.0735 0.0885)
+(0.0030 0.0735 0.0885)
+(0.0060 0.0735 0.0885)
+(-0.0060 -0.0735 0.0915)
+(-0.0030 -0.0735 0.0915)
+(0.0000 -0.0735 0.0915)
+(0.0030 -0.0735 0.0915)
+(0.0060 -0.0735 0.0915)
+(-0.0060 -0.0705 0.0915)
+(-0.0030 -0.0705 0.0915)
+(0.0000 -0.0705 0.0915)
+(0.0030 -0.0705 0.0915)
+(0.0060 -0.0705 0.0915)
+(-0.0060 -0.0675 0.0915)
+(-0.0030 -0.0675 0.0915)
+(0.0000 -0.0675 0.0915)
+(0.0030 -0.0675 0.0915)
+(0.0060 -0.0675 0.0915)
+(-0.0060 -0.0645 0.0915)
+(-0.0030 -0.0645 0.0915)
+(0.0000 -0.0645 0.0915)
+(0.0030 -0.0645 0.0915)
+(0.0060 -0.0645 0.0915)
+(-0.0060 -0.0615 0.0915)
+(-0.0030 -0.0615 0.0915)
+(0.0000 -0.0615 0.0915)
+(0.0030 -0.0615 0.0915)
+(0.0060 -0.0615 0.0915)
+(-0.0060 -0.0585 0.0915)
+(-0.0030 -0.0585 0.0915)
+(0.0000 -0.0585 0.0915)
+(0.0030 -0.0585 0.0915)
+(0.0060 -0.0585 0.0915)
+(-0.0060 -0.0555 0.0915)
+(-0.0030 -0.0555 0.0915)
+(0.0000 -0.0555 0.0915)
+(0.0030 -0.0555 0.0915)
+(0.0060 -0.0555 0.0915)
+(-0.0060 -0.0525 0.0915)
+(-0.0030 -0.0525 0.0915)
+(0.0000 -0.0525 0.0915)
+(0.0030 -0.0525 0.0915)
+(0.0060 -0.0525 0.0915)
+(-0.0060 -0.0495 0.0915)
+(-0.0030 -0.0495 0.0915)
+(0.0000 -0.0495 0.0915)
+(0.0030 -0.0495 0.0915)
+(0.0060 -0.0495 0.0915)
+(-0.0060 -0.0465 0.0915)
+(-0.0030 -0.0465 0.0915)
+(0.0000 -0.0465 0.0915)
+(0.0030 -0.0465 0.0915)
+(0.0060 -0.0465 0.0915)
+(-0.0060 -0.0435 0.0915)
+(-0.0030 -0.0435 0.0915)
+(0.0000 -0.0435 0.0915)
+(0.0030 -0.0435 0.0915)
+(0.0060 -0.0435 0.0915)
+(-0.0060 -0.0405 0.0915)
+(-0.0030 -0.0405 0.0915)
+(0.0000 -0.0405 0.0915)
+(0.0030 -0.0405 0.0915)
+(0.0060 -0.0405 0.0915)
+(-0.0060 -0.0375 0.0915)
+(-0.0030 -0.0375 0.0915)
+(0.0000 -0.0375 0.0915)
+(0.0030 -0.0375 0.0915)
+(0.0060 -0.0375 0.0915)
+(-0.0060 -0.0345 0.0915)
+(-0.0030 -0.0345 0.0915)
+(0.0000 -0.0345 0.0915)
+(0.0030 -0.0345 0.0915)
+(0.0060 -0.0345 0.0915)
+(-0.0060 -0.0315 0.0915)
+(-0.0030 -0.0315 0.0915)
+(0.0000 -0.0315 0.0915)
+(0.0030 -0.0315 0.0915)
+(0.0060 -0.0315 0.0915)
+(-0.0060 -0.0285 0.0915)
+(-0.0030 -0.0285 0.0915)
+(0.0000 -0.0285 0.0915)
+(0.0030 -0.0285 0.0915)
+(0.0060 -0.0285 0.0915)
+(-0.0060 -0.0255 0.0915)
+(-0.0030 -0.0255 0.0915)
+(0.0000 -0.0255 0.0915)
+(0.0030 -0.0255 0.0915)
+(0.0060 -0.0255 0.0915)
+(-0.0060 -0.0225 0.0915)
+(-0.0030 -0.0225 0.0915)
+(0.0000 -0.0225 0.0915)
+(0.0030 -0.0225 0.0915)
+(0.0060 -0.0225 0.0915)
+(-0.0060 -0.0195 0.0915)
+(-0.0030 -0.0195 0.0915)
+(0.0000 -0.0195 0.0915)
+(0.0030 -0.0195 0.0915)
+(0.0060 -0.0195 0.0915)
+(-0.0060 -0.0165 0.0915)
+(-0.0030 -0.0165 0.0915)
+(0.0000 -0.0165 0.0915)
+(0.0030 -0.0165 0.0915)
+(0.0060 -0.0165 0.0915)
+(-0.0060 -0.0135 0.0915)
+(-0.0030 -0.0135 0.0915)
+(0.0000 -0.0135 0.0915)
+(0.0030 -0.0135 0.0915)
+(0.0060 -0.0135 0.0915)
+(-0.0060 -0.0105 0.0915)
+(-0.0030 -0.0105 0.0915)
+(0.0000 -0.0105 0.0915)
+(0.0030 -0.0105 0.0915)
+(0.0060 -0.0105 0.0915)
+(-0.0060 -0.0075 0.0915)
+(-0.0030 -0.0075 0.0915)
+(0.0000 -0.0075 0.0915)
+(0.0030 -0.0075 0.0915)
+(0.0060 -0.0075 0.0915)
+(-0.0060 -0.0045 0.0915)
+(-0.0030 -0.0045 0.0915)
+(0.0000 -0.0045 0.0915)
+(0.0030 -0.0045 0.0915)
+(0.0060 -0.0045 0.0915)
+(-0.0060 -0.0015 0.0915)
+(-0.0030 -0.0015 0.0915)
+(0.0000 -0.0015 0.0915)
+(0.0030 -0.0015 0.0915)
+(0.0060 -0.0015 0.0915)
+(-0.0060 0.0015 0.0915)
+(-0.0030 0.0015 0.0915)
+(0.0000 0.0015 0.0915)
+(0.0030 0.0015 0.0915)
+(0.0060 0.0015 0.0915)
+(-0.0060 0.0045 0.0915)
+(-0.0030 0.0045 0.0915)
+(0.0000 0.0045 0.0915)
+(0.0030 0.0045 0.0915)
+(0.0060 0.0045 0.0915)
+(-0.0060 0.0075 0.0915)
+(-0.0030 0.0075 0.0915)
+(0.0000 0.0075 0.0915)
+(0.0030 0.0075 0.0915)
+(0.0060 0.0075 0.0915)
+(-0.0060 0.0105 0.0915)
+(-0.0030 0.0105 0.0915)
+(0.0000 0.0105 0.0915)
+(0.0030 0.0105 0.0915)
+(0.0060 0.0105 0.0915)
+(-0.0060 0.0135 0.0915)
+(-0.0030 0.0135 0.0915)
+(0.0000 0.0135 0.0915)
+(0.0030 0.0135 0.0915)
+(0.0060 0.0135 0.0915)
+(-0.0060 0.0165 0.0915)
+(-0.0030 0.0165 0.0915)
+(0.0000 0.0165 0.0915)
+(0.0030 0.0165 0.0915)
+(0.0060 0.0165 0.0915)
+(-0.0060 0.0195 0.0915)
+(-0.0030 0.0195 0.0915)
+(0.0000 0.0195 0.0915)
+(0.0030 0.0195 0.0915)
+(0.0060 0.0195 0.0915)
+(-0.0060 0.0225 0.0915)
+(-0.0030 0.0225 0.0915)
+(0.0000 0.0225 0.0915)
+(0.0030 0.0225 0.0915)
+(0.0060 0.0225 0.0915)
+(-0.0060 0.0255 0.0915)
+(-0.0030 0.0255 0.0915)
+(0.0000 0.0255 0.0915)
+(0.0030 0.0255 0.0915)
+(0.0060 0.0255 0.0915)
+(-0.0060 0.0285 0.0915)
+(-0.0030 0.0285 0.0915)
+(0.0000 0.0285 0.0915)
+(0.0030 0.0285 0.0915)
+(0.0060 0.0285 0.0915)
+(-0.0060 0.0315 0.0915)
+(-0.0030 0.0315 0.0915)
+(0.0000 0.0315 0.0915)
+(0.0030 0.0315 0.0915)
+(0.0060 0.0315 0.0915)
+(-0.0060 0.0345 0.0915)
+(-0.0030 0.0345 0.0915)
+(0.0000 0.0345 0.0915)
+(0.0030 0.0345 0.0915)
+(0.0060 0.0345 0.0915)
+(-0.0060 0.0375 0.0915)
+(-0.0030 0.0375 0.0915)
+(0.0000 0.0375 0.0915)
+(0.0030 0.0375 0.0915)
+(0.0060 0.0375 0.0915)
+(-0.0060 0.0405 0.0915)
+(-0.0030 0.0405 0.0915)
+(0.0000 0.0405 0.0915)
+(0.0030 0.0405 0.0915)
+(0.0060 0.0405 0.0915)
+(-0.0060 0.0435 0.0915)
+(-0.0030 0.0435 0.0915)
+(0.0000 0.0435 0.0915)
+(0.0030 0.0435 0.0915)
+(0.0060 0.0435 0.0915)
+(-0.0060 0.0465 0.0915)
+(-0.0030 0.0465 0.0915)
+(0.0000 0.0465 0.0915)
+(0.0030 0.0465 0.0915)
+(0.0060 0.0465 0.0915)
+(-0.0060 0.0495 0.0915)
+(-0.0030 0.0495 0.0915)
+(0.0000 0.0495 0.0915)
+(0.0030 0.0495 0.0915)
+(0.0060 0.0495 0.0915)
+(-0.0060 0.0525 0.0915)
+(-0.0030 0.0525 0.0915)
+(0.0000 0.0525 0.0915)
+(0.0030 0.0525 0.0915)
+(0.0060 0.0525 0.0915)
+(-0.0060 0.0555 0.0915)
+(-0.0030 0.0555 0.0915)
+(0.0000 0.0555 0.0915)
+(0.0030 0.0555 0.0915)
+(0.0060 0.0555 0.0915)
+(-0.0060 0.0585 0.0915)
+(-0.0030 0.0585 0.0915)
+(0.0000 0.0585 0.0915)
+(0.0030 0.0585 0.0915)
+(0.0060 0.0585 0.0915)
+(-0.0060 0.0615 0.0915)
+(-0.0030 0.0615 0.0915)
+(0.0000 0.0615 0.0915)
+(0.0030 0.0615 0.0915)
+(0.0060 0.0615 0.0915)
+(-0.0060 0.0645 0.0915)
+(-0.0030 0.0645 0.0915)
+(0.0000 0.0645 0.0915)
+(0.0030 0.0645 0.0915)
+(0.0060 0.0645 0.0915)
+(-0.0060 0.0675 0.0915)
+(-0.0030 0.0675 0.0915)
+(0.0000 0.0675 0.0915)
+(0.0030 0.0675 0.0915)
+(0.0060 0.0675 0.0915)
+(-0.0060 0.0705 0.0915)
+(-0.0030 0.0705 0.0915)
+(0.0000 0.0705 0.0915)
+(0.0030 0.0705 0.0915)
+(0.0060 0.0705 0.0915)
+(-0.0060 0.0735 0.0915)
+(-0.0030 0.0735 0.0915)
+(0.0000 0.0735 0.0915)
+(0.0030 0.0735 0.0915)
+(0.0060 0.0735 0.0915)
+(-0.0060 -0.0735 0.0945)
+(-0.0030 -0.0735 0.0945)
+(0.0000 -0.0735 0.0945)
+(0.0030 -0.0735 0.0945)
+(0.0060 -0.0735 0.0945)
+(-0.0060 -0.0705 0.0945)
+(-0.0030 -0.0705 0.0945)
+(0.0000 -0.0705 0.0945)
+(0.0030 -0.0705 0.0945)
+(0.0060 -0.0705 0.0945)
+(-0.0060 -0.0675 0.0945)
+(-0.0030 -0.0675 0.0945)
+(0.0000 -0.0675 0.0945)
+(0.0030 -0.0675 0.0945)
+(0.0060 -0.0675 0.0945)
+(-0.0060 -0.0645 0.0945)
+(-0.0030 -0.0645 0.0945)
+(0.0000 -0.0645 0.0945)
+(0.0030 -0.0645 0.0945)
+(0.0060 -0.0645 0.0945)
+(-0.0060 -0.0615 0.0945)
+(-0.0030 -0.0615 0.0945)
+(0.0000 -0.0615 0.0945)
+(0.0030 -0.0615 0.0945)
+(0.0060 -0.0615 0.0945)
+(-0.0060 -0.0585 0.0945)
+(-0.0030 -0.0585 0.0945)
+(0.0000 -0.0585 0.0945)
+(0.0030 -0.0585 0.0945)
+(0.0060 -0.0585 0.0945)
+(-0.0060 -0.0555 0.0945)
+(-0.0030 -0.0555 0.0945)
+(0.0000 -0.0555 0.0945)
+(0.0030 -0.0555 0.0945)
+(0.0060 -0.0555 0.0945)
+(-0.0060 -0.0525 0.0945)
+(-0.0030 -0.0525 0.0945)
+(0.0000 -0.0525 0.0945)
+(0.0030 -0.0525 0.0945)
+(0.0060 -0.0525 0.0945)
+(-0.0060 -0.0495 0.0945)
+(-0.0030 -0.0495 0.0945)
+(0.0000 -0.0495 0.0945)
+(0.0030 -0.0495 0.0945)
+(0.0060 -0.0495 0.0945)
+(-0.0060 -0.0465 0.0945)
+(-0.0030 -0.0465 0.0945)
+(0.0000 -0.0465 0.0945)
+(0.0030 -0.0465 0.0945)
+(0.0060 -0.0465 0.0945)
+(-0.0060 -0.0435 0.0945)
+(-0.0030 -0.0435 0.0945)
+(0.0000 -0.0435 0.0945)
+(0.0030 -0.0435 0.0945)
+(0.0060 -0.0435 0.0945)
+(-0.0060 -0.0405 0.0945)
+(-0.0030 -0.0405 0.0945)
+(0.0000 -0.0405 0.0945)
+(0.0030 -0.0405 0.0945)
+(0.0060 -0.0405 0.0945)
+(-0.0060 -0.0375 0.0945)
+(-0.0030 -0.0375 0.0945)
+(0.0000 -0.0375 0.0945)
+(0.0030 -0.0375 0.0945)
+(0.0060 -0.0375 0.0945)
+(-0.0060 -0.0345 0.0945)
+(-0.0030 -0.0345 0.0945)
+(0.0000 -0.0345 0.0945)
+(0.0030 -0.0345 0.0945)
+(0.0060 -0.0345 0.0945)
+(-0.0060 -0.0315 0.0945)
+(-0.0030 -0.0315 0.0945)
+(0.0000 -0.0315 0.0945)
+(0.0030 -0.0315 0.0945)
+(0.0060 -0.0315 0.0945)
+(-0.0060 -0.0285 0.0945)
+(-0.0030 -0.0285 0.0945)
+(0.0000 -0.0285 0.0945)
+(0.0030 -0.0285 0.0945)
+(0.0060 -0.0285 0.0945)
+(-0.0060 -0.0255 0.0945)
+(-0.0030 -0.0255 0.0945)
+(0.0000 -0.0255 0.0945)
+(0.0030 -0.0255 0.0945)
+(0.0060 -0.0255 0.0945)
+(-0.0060 -0.0225 0.0945)
+(-0.0030 -0.0225 0.0945)
+(0.0000 -0.0225 0.0945)
+(0.0030 -0.0225 0.0945)
+(0.0060 -0.0225 0.0945)
+(-0.0060 -0.0195 0.0945)
+(-0.0030 -0.0195 0.0945)
+(0.0000 -0.0195 0.0945)
+(0.0030 -0.0195 0.0945)
+(0.0060 -0.0195 0.0945)
+(-0.0060 -0.0165 0.0945)
+(-0.0030 -0.0165 0.0945)
+(0.0000 -0.0165 0.0945)
+(0.0030 -0.0165 0.0945)
+(0.0060 -0.0165 0.0945)
+(-0.0060 -0.0135 0.0945)
+(-0.0030 -0.0135 0.0945)
+(0.0000 -0.0135 0.0945)
+(0.0030 -0.0135 0.0945)
+(0.0060 -0.0135 0.0945)
+(-0.0060 -0.0105 0.0945)
+(-0.0030 -0.0105 0.0945)
+(0.0000 -0.0105 0.0945)
+(0.0030 -0.0105 0.0945)
+(0.0060 -0.0105 0.0945)
+(-0.0060 -0.0075 0.0945)
+(-0.0030 -0.0075 0.0945)
+(0.0000 -0.0075 0.0945)
+(0.0030 -0.0075 0.0945)
+(0.0060 -0.0075 0.0945)
+(-0.0060 -0.0045 0.0945)
+(-0.0030 -0.0045 0.0945)
+(0.0000 -0.0045 0.0945)
+(0.0030 -0.0045 0.0945)
+(0.0060 -0.0045 0.0945)
+(-0.0060 -0.0015 0.0945)
+(-0.0030 -0.0015 0.0945)
+(0.0000 -0.0015 0.0945)
+(0.0030 -0.0015 0.0945)
+(0.0060 -0.0015 0.0945)
+(-0.0060 0.0015 0.0945)
+(-0.0030 0.0015 0.0945)
+(0.0000 0.0015 0.0945)
+(0.0030 0.0015 0.0945)
+(0.0060 0.0015 0.0945)
+(-0.0060 0.0045 0.0945)
+(-0.0030 0.0045 0.0945)
+(0.0000 0.0045 0.0945)
+(0.0030 0.0045 0.0945)
+(0.0060 0.0045 0.0945)
+(-0.0060 0.0075 0.0945)
+(-0.0030 0.0075 0.0945)
+(0.0000 0.0075 0.0945)
+(0.0030 0.0075 0.0945)
+(0.0060 0.0075 0.0945)
+(-0.0060 0.0105 0.0945)
+(-0.0030 0.0105 0.0945)
+(0.0000 0.0105 0.0945)
+(0.0030 0.0105 0.0945)
+(0.0060 0.0105 0.0945)
+(-0.0060 0.0135 0.0945)
+(-0.0030 0.0135 0.0945)
+(0.0000 0.0135 0.0945)
+(0.0030 0.0135 0.0945)
+(0.0060 0.0135 0.0945)
+(-0.0060 0.0165 0.0945)
+(-0.0030 0.0165 0.0945)
+(0.0000 0.0165 0.0945)
+(0.0030 0.0165 0.0945)
+(0.0060 0.0165 0.0945)
+(-0.0060 0.0195 0.0945)
+(-0.0030 0.0195 0.0945)
+(0.0000 0.0195 0.0945)
+(0.0030 0.0195 0.0945)
+(0.0060 0.0195 0.0945)
+(-0.0060 0.0225 0.0945)
+(-0.0030 0.0225 0.0945)
+(0.0000 0.0225 0.0945)
+(0.0030 0.0225 0.0945)
+(0.0060 0.0225 0.0945)
+(-0.0060 0.0255 0.0945)
+(-0.0030 0.0255 0.0945)
+(0.0000 0.0255 0.0945)
+(0.0030 0.0255 0.0945)
+(0.0060 0.0255 0.0945)
+(-0.0060 0.0285 0.0945)
+(-0.0030 0.0285 0.0945)
+(0.0000 0.0285 0.0945)
+(0.0030 0.0285 0.0945)
+(0.0060 0.0285 0.0945)
+(-0.0060 0.0315 0.0945)
+(-0.0030 0.0315 0.0945)
+(0.0000 0.0315 0.0945)
+(0.0030 0.0315 0.0945)
+(0.0060 0.0315 0.0945)
+(-0.0060 0.0345 0.0945)
+(-0.0030 0.0345 0.0945)
+(0.0000 0.0345 0.0945)
+(0.0030 0.0345 0.0945)
+(0.0060 0.0345 0.0945)
+(-0.0060 0.0375 0.0945)
+(-0.0030 0.0375 0.0945)
+(0.0000 0.0375 0.0945)
+(0.0030 0.0375 0.0945)
+(0.0060 0.0375 0.0945)
+(-0.0060 0.0405 0.0945)
+(-0.0030 0.0405 0.0945)
+(0.0000 0.0405 0.0945)
+(0.0030 0.0405 0.0945)
+(0.0060 0.0405 0.0945)
+(-0.0060 0.0435 0.0945)
+(-0.0030 0.0435 0.0945)
+(0.0000 0.0435 0.0945)
+(0.0030 0.0435 0.0945)
+(0.0060 0.0435 0.0945)
+(-0.0060 0.0465 0.0945)
+(-0.0030 0.0465 0.0945)
+(0.0000 0.0465 0.0945)
+(0.0030 0.0465 0.0945)
+(0.0060 0.0465 0.0945)
+(-0.0060 0.0495 0.0945)
+(-0.0030 0.0495 0.0945)
+(0.0000 0.0495 0.0945)
+(0.0030 0.0495 0.0945)
+(0.0060 0.0495 0.0945)
+(-0.0060 0.0525 0.0945)
+(-0.0030 0.0525 0.0945)
+(0.0000 0.0525 0.0945)
+(0.0030 0.0525 0.0945)
+(0.0060 0.0525 0.0945)
+(-0.0060 0.0555 0.0945)
+(-0.0030 0.0555 0.0945)
+(0.0000 0.0555 0.0945)
+(0.0030 0.0555 0.0945)
+(0.0060 0.0555 0.0945)
+(-0.0060 0.0585 0.0945)
+(-0.0030 0.0585 0.0945)
+(0.0000 0.0585 0.0945)
+(0.0030 0.0585 0.0945)
+(0.0060 0.0585 0.0945)
+(-0.0060 0.0615 0.0945)
+(-0.0030 0.0615 0.0945)
+(0.0000 0.0615 0.0945)
+(0.0030 0.0615 0.0945)
+(0.0060 0.0615 0.0945)
+(-0.0060 0.0645 0.0945)
+(-0.0030 0.0645 0.0945)
+(0.0000 0.0645 0.0945)
+(0.0030 0.0645 0.0945)
+(0.0060 0.0645 0.0945)
+(-0.0060 0.0675 0.0945)
+(-0.0030 0.0675 0.0945)
+(0.0000 0.0675 0.0945)
+(0.0030 0.0675 0.0945)
+(0.0060 0.0675 0.0945)
+(-0.0060 0.0705 0.0945)
+(-0.0030 0.0705 0.0945)
+(0.0000 0.0705 0.0945)
+(0.0030 0.0705 0.0945)
+(0.0060 0.0705 0.0945)
+(-0.0060 0.0735 0.0945)
+(-0.0030 0.0735 0.0945)
+(0.0000 0.0735 0.0945)
+(0.0030 0.0735 0.0945)
+(0.0060 0.0735 0.0945)
+(-0.0060 -0.0735 0.0975)
+(-0.0030 -0.0735 0.0975)
+(0.0000 -0.0735 0.0975)
+(0.0030 -0.0735 0.0975)
+(0.0060 -0.0735 0.0975)
+(-0.0060 -0.0705 0.0975)
+(-0.0030 -0.0705 0.0975)
+(0.0000 -0.0705 0.0975)
+(0.0030 -0.0705 0.0975)
+(0.0060 -0.0705 0.0975)
+(-0.0060 -0.0675 0.0975)
+(-0.0030 -0.0675 0.0975)
+(0.0000 -0.0675 0.0975)
+(0.0030 -0.0675 0.0975)
+(0.0060 -0.0675 0.0975)
+(-0.0060 -0.0645 0.0975)
+(-0.0030 -0.0645 0.0975)
+(0.0000 -0.0645 0.0975)
+(0.0030 -0.0645 0.0975)
+(0.0060 -0.0645 0.0975)
+(-0.0060 -0.0615 0.0975)
+(-0.0030 -0.0615 0.0975)
+(0.0000 -0.0615 0.0975)
+(0.0030 -0.0615 0.0975)
+(0.0060 -0.0615 0.0975)
+(-0.0060 -0.0585 0.0975)
+(-0.0030 -0.0585 0.0975)
+(0.0000 -0.0585 0.0975)
+(0.0030 -0.0585 0.0975)
+(0.0060 -0.0585 0.0975)
+(-0.0060 -0.0555 0.0975)
+(-0.0030 -0.0555 0.0975)
+(0.0000 -0.0555 0.0975)
+(0.0030 -0.0555 0.0975)
+(0.0060 -0.0555 0.0975)
+(-0.0060 -0.0525 0.0975)
+(-0.0030 -0.0525 0.0975)
+(0.0000 -0.0525 0.0975)
+(0.0030 -0.0525 0.0975)
+(0.0060 -0.0525 0.0975)
+(-0.0060 -0.0495 0.0975)
+(-0.0030 -0.0495 0.0975)
+(0.0000 -0.0495 0.0975)
+(0.0030 -0.0495 0.0975)
+(0.0060 -0.0495 0.0975)
+(-0.0060 -0.0465 0.0975)
+(-0.0030 -0.0465 0.0975)
+(0.0000 -0.0465 0.0975)
+(0.0030 -0.0465 0.0975)
+(0.0060 -0.0465 0.0975)
+(-0.0060 -0.0435 0.0975)
+(-0.0030 -0.0435 0.0975)
+(0.0000 -0.0435 0.0975)
+(0.0030 -0.0435 0.0975)
+(0.0060 -0.0435 0.0975)
+(-0.0060 -0.0405 0.0975)
+(-0.0030 -0.0405 0.0975)
+(0.0000 -0.0405 0.0975)
+(0.0030 -0.0405 0.0975)
+(0.0060 -0.0405 0.0975)
+(-0.0060 -0.0375 0.0975)
+(-0.0030 -0.0375 0.0975)
+(0.0000 -0.0375 0.0975)
+(0.0030 -0.0375 0.0975)
+(0.0060 -0.0375 0.0975)
+(-0.0060 -0.0345 0.0975)
+(-0.0030 -0.0345 0.0975)
+(0.0000 -0.0345 0.0975)
+(0.0030 -0.0345 0.0975)
+(0.0060 -0.0345 0.0975)
+(-0.0060 -0.0315 0.0975)
+(-0.0030 -0.0315 0.0975)
+(0.0000 -0.0315 0.0975)
+(0.0030 -0.0315 0.0975)
+(0.0060 -0.0315 0.0975)
+(-0.0060 -0.0285 0.0975)
+(-0.0030 -0.0285 0.0975)
+(0.0000 -0.0285 0.0975)
+(0.0030 -0.0285 0.0975)
+(0.0060 -0.0285 0.0975)
+(-0.0060 -0.0255 0.0975)
+(-0.0030 -0.0255 0.0975)
+(0.0000 -0.0255 0.0975)
+(0.0030 -0.0255 0.0975)
+(0.0060 -0.0255 0.0975)
+(-0.0060 -0.0225 0.0975)
+(-0.0030 -0.0225 0.0975)
+(0.0000 -0.0225 0.0975)
+(0.0030 -0.0225 0.0975)
+(0.0060 -0.0225 0.0975)
+(-0.0060 -0.0195 0.0975)
+(-0.0030 -0.0195 0.0975)
+(0.0000 -0.0195 0.0975)
+(0.0030 -0.0195 0.0975)
+(0.0060 -0.0195 0.0975)
+(-0.0060 -0.0165 0.0975)
+(-0.0030 -0.0165 0.0975)
+(0.0000 -0.0165 0.0975)
+(0.0030 -0.0165 0.0975)
+(0.0060 -0.0165 0.0975)
+(-0.0060 -0.0135 0.0975)
+(-0.0030 -0.0135 0.0975)
+(0.0000 -0.0135 0.0975)
+(0.0030 -0.0135 0.0975)
+(0.0060 -0.0135 0.0975)
+(-0.0060 -0.0105 0.0975)
+(-0.0030 -0.0105 0.0975)
+(0.0000 -0.0105 0.0975)
+(0.0030 -0.0105 0.0975)
+(0.0060 -0.0105 0.0975)
+(-0.0060 -0.0075 0.0975)
+(-0.0030 -0.0075 0.0975)
+(0.0000 -0.0075 0.0975)
+(0.0030 -0.0075 0.0975)
+(0.0060 -0.0075 0.0975)
+(-0.0060 -0.0045 0.0975)
+(-0.0030 -0.0045 0.0975)
+(0.0000 -0.0045 0.0975)
+(0.0030 -0.0045 0.0975)
+(0.0060 -0.0045 0.0975)
+(-0.0060 -0.0015 0.0975)
+(-0.0030 -0.0015 0.0975)
+(0.0000 -0.0015 0.0975)
+(0.0030 -0.0015 0.0975)
+(0.0060 -0.0015 0.0975)
+(-0.0060 0.0015 0.0975)
+(-0.0030 0.0015 0.0975)
+(0.0000 0.0015 0.0975)
+(0.0030 0.0015 0.0975)
+(0.0060 0.0015 0.0975)
+(-0.0060 0.0045 0.0975)
+(-0.0030 0.0045 0.0975)
+(0.0000 0.0045 0.0975)
+(0.0030 0.0045 0.0975)
+(0.0060 0.0045 0.0975)
+(-0.0060 0.0075 0.0975)
+(-0.0030 0.0075 0.0975)
+(0.0000 0.0075 0.0975)
+(0.0030 0.0075 0.0975)
+(0.0060 0.0075 0.0975)
+(-0.0060 0.0105 0.0975)
+(-0.0030 0.0105 0.0975)
+(0.0000 0.0105 0.0975)
+(0.0030 0.0105 0.0975)
+(0.0060 0.0105 0.0975)
+(-0.0060 0.0135 0.0975)
+(-0.0030 0.0135 0.0975)
+(0.0000 0.0135 0.0975)
+(0.0030 0.0135 0.0975)
+(0.0060 0.0135 0.0975)
+(-0.0060 0.0165 0.0975)
+(-0.0030 0.0165 0.0975)
+(0.0000 0.0165 0.0975)
+(0.0030 0.0165 0.0975)
+(0.0060 0.0165 0.0975)
+(-0.0060 0.0195 0.0975)
+(-0.0030 0.0195 0.0975)
+(0.0000 0.0195 0.0975)
+(0.0030 0.0195 0.0975)
+(0.0060 0.0195 0.0975)
+(-0.0060 0.0225 0.0975)
+(-0.0030 0.0225 0.0975)
+(0.0000 0.0225 0.0975)
+(0.0030 0.0225 0.0975)
+(0.0060 0.0225 0.0975)
+(-0.0060 0.0255 0.0975)
+(-0.0030 0.0255 0.0975)
+(0.0000 0.0255 0.0975)
+(0.0030 0.0255 0.0975)
+(0.0060 0.0255 0.0975)
+(-0.0060 0.0285 0.0975)
+(-0.0030 0.0285 0.0975)
+(0.0000 0.0285 0.0975)
+(0.0030 0.0285 0.0975)
+(0.0060 0.0285 0.0975)
+(-0.0060 0.0315 0.0975)
+(-0.0030 0.0315 0.0975)
+(0.0000 0.0315 0.0975)
+(0.0030 0.0315 0.0975)
+(0.0060 0.0315 0.0975)
+(-0.0060 0.0345 0.0975)
+(-0.0030 0.0345 0.0975)
+(0.0000 0.0345 0.0975)
+(0.0030 0.0345 0.0975)
+(0.0060 0.0345 0.0975)
+(-0.0060 0.0375 0.0975)
+(-0.0030 0.0375 0.0975)
+(0.0000 0.0375 0.0975)
+(0.0030 0.0375 0.0975)
+(0.0060 0.0375 0.0975)
+(-0.0060 0.0405 0.0975)
+(-0.0030 0.0405 0.0975)
+(0.0000 0.0405 0.0975)
+(0.0030 0.0405 0.0975)
+(0.0060 0.0405 0.0975)
+(-0.0060 0.0435 0.0975)
+(-0.0030 0.0435 0.0975)
+(0.0000 0.0435 0.0975)
+(0.0030 0.0435 0.0975)
+(0.0060 0.0435 0.0975)
+(-0.0060 0.0465 0.0975)
+(-0.0030 0.0465 0.0975)
+(0.0000 0.0465 0.0975)
+(0.0030 0.0465 0.0975)
+(0.0060 0.0465 0.0975)
+(-0.0060 0.0495 0.0975)
+(-0.0030 0.0495 0.0975)
+(0.0000 0.0495 0.0975)
+(0.0030 0.0495 0.0975)
+(0.0060 0.0495 0.0975)
+(-0.0060 0.0525 0.0975)
+(-0.0030 0.0525 0.0975)
+(0.0000 0.0525 0.0975)
+(0.0030 0.0525 0.0975)
+(0.0060 0.0525 0.0975)
+(-0.0060 0.0555 0.0975)
+(-0.0030 0.0555 0.0975)
+(0.0000 0.0555 0.0975)
+(0.0030 0.0555 0.0975)
+(0.0060 0.0555 0.0975)
+(-0.0060 0.0585 0.0975)
+(-0.0030 0.0585 0.0975)
+(0.0000 0.0585 0.0975)
+(0.0030 0.0585 0.0975)
+(0.0060 0.0585 0.0975)
+(-0.0060 0.0615 0.0975)
+(-0.0030 0.0615 0.0975)
+(0.0000 0.0615 0.0975)
+(0.0030 0.0615 0.0975)
+(0.0060 0.0615 0.0975)
+(-0.0060 0.0645 0.0975)
+(-0.0030 0.0645 0.0975)
+(0.0000 0.0645 0.0975)
+(0.0030 0.0645 0.0975)
+(0.0060 0.0645 0.0975)
+(-0.0060 0.0675 0.0975)
+(-0.0030 0.0675 0.0975)
+(0.0000 0.0675 0.0975)
+(0.0030 0.0675 0.0975)
+(0.0060 0.0675 0.0975)
+(-0.0060 0.0705 0.0975)
+(-0.0030 0.0705 0.0975)
+(0.0000 0.0705 0.0975)
+(0.0030 0.0705 0.0975)
+(0.0060 0.0705 0.0975)
+(-0.0060 0.0735 0.0975)
+(-0.0030 0.0735 0.0975)
+(0.0000 0.0735 0.0975)
+(0.0030 0.0735 0.0975)
+(0.0060 0.0735 0.0975)
+(-0.0060 -0.0735 0.1005)
+(-0.0030 -0.0735 0.1005)
+(0.0000 -0.0735 0.1005)
+(0.0030 -0.0735 0.1005)
+(0.0060 -0.0735 0.1005)
+(-0.0060 -0.0705 0.1005)
+(-0.0030 -0.0705 0.1005)
+(0.0000 -0.0705 0.1005)
+(0.0030 -0.0705 0.1005)
+(0.0060 -0.0705 0.1005)
+(-0.0060 -0.0675 0.1005)
+(-0.0030 -0.0675 0.1005)
+(0.0000 -0.0675 0.1005)
+(0.0030 -0.0675 0.1005)
+(0.0060 -0.0675 0.1005)
+(-0.0060 -0.0645 0.1005)
+(-0.0030 -0.0645 0.1005)
+(0.0000 -0.0645 0.1005)
+(0.0030 -0.0645 0.1005)
+(0.0060 -0.0645 0.1005)
+(-0.0060 -0.0615 0.1005)
+(-0.0030 -0.0615 0.1005)
+(0.0000 -0.0615 0.1005)
+(0.0030 -0.0615 0.1005)
+(0.0060 -0.0615 0.1005)
+(-0.0060 -0.0585 0.1005)
+(-0.0030 -0.0585 0.1005)
+(0.0000 -0.0585 0.1005)
+(0.0030 -0.0585 0.1005)
+(0.0060 -0.0585 0.1005)
+(-0.0060 -0.0555 0.1005)
+(-0.0030 -0.0555 0.1005)
+(0.0000 -0.0555 0.1005)
+(0.0030 -0.0555 0.1005)
+(0.0060 -0.0555 0.1005)
+(-0.0060 -0.0525 0.1005)
+(-0.0030 -0.0525 0.1005)
+(0.0000 -0.0525 0.1005)
+(0.0030 -0.0525 0.1005)
+(0.0060 -0.0525 0.1005)
+(-0.0060 -0.0495 0.1005)
+(-0.0030 -0.0495 0.1005)
+(0.0000 -0.0495 0.1005)
+(0.0030 -0.0495 0.1005)
+(0.0060 -0.0495 0.1005)
+(-0.0060 -0.0465 0.1005)
+(-0.0030 -0.0465 0.1005)
+(0.0000 -0.0465 0.1005)
+(0.0030 -0.0465 0.1005)
+(0.0060 -0.0465 0.1005)
+(-0.0060 -0.0435 0.1005)
+(-0.0030 -0.0435 0.1005)
+(0.0000 -0.0435 0.1005)
+(0.0030 -0.0435 0.1005)
+(0.0060 -0.0435 0.1005)
+(-0.0060 -0.0405 0.1005)
+(-0.0030 -0.0405 0.1005)
+(0.0000 -0.0405 0.1005)
+(0.0030 -0.0405 0.1005)
+(0.0060 -0.0405 0.1005)
+(-0.0060 -0.0375 0.1005)
+(-0.0030 -0.0375 0.1005)
+(0.0000 -0.0375 0.1005)
+(0.0030 -0.0375 0.1005)
+(0.0060 -0.0375 0.1005)
+(-0.0060 -0.0345 0.1005)
+(-0.0030 -0.0345 0.1005)
+(0.0000 -0.0345 0.1005)
+(0.0030 -0.0345 0.1005)
+(0.0060 -0.0345 0.1005)
+(-0.0060 -0.0315 0.1005)
+(-0.0030 -0.0315 0.1005)
+(0.0000 -0.0315 0.1005)
+(0.0030 -0.0315 0.1005)
+(0.0060 -0.0315 0.1005)
+(-0.0060 -0.0285 0.1005)
+(-0.0030 -0.0285 0.1005)
+(0.0000 -0.0285 0.1005)
+(0.0030 -0.0285 0.1005)
+(0.0060 -0.0285 0.1005)
+(-0.0060 -0.0255 0.1005)
+(-0.0030 -0.0255 0.1005)
+(0.0000 -0.0255 0.1005)
+(0.0030 -0.0255 0.1005)
+(0.0060 -0.0255 0.1005)
+(-0.0060 -0.0225 0.1005)
+(-0.0030 -0.0225 0.1005)
+(0.0000 -0.0225 0.1005)
+(0.0030 -0.0225 0.1005)
+(0.0060 -0.0225 0.1005)
+(-0.0060 -0.0195 0.1005)
+(-0.0030 -0.0195 0.1005)
+(0.0000 -0.0195 0.1005)
+(0.0030 -0.0195 0.1005)
+(0.0060 -0.0195 0.1005)
+(-0.0060 -0.0165 0.1005)
+(-0.0030 -0.0165 0.1005)
+(0.0000 -0.0165 0.1005)
+(0.0030 -0.0165 0.1005)
+(0.0060 -0.0165 0.1005)
+(-0.0060 -0.0135 0.1005)
+(-0.0030 -0.0135 0.1005)
+(0.0000 -0.0135 0.1005)
+(0.0030 -0.0135 0.1005)
+(0.0060 -0.0135 0.1005)
+(-0.0060 -0.0105 0.1005)
+(-0.0030 -0.0105 0.1005)
+(0.0000 -0.0105 0.1005)
+(0.0030 -0.0105 0.1005)
+(0.0060 -0.0105 0.1005)
+(-0.0060 -0.0075 0.1005)
+(-0.0030 -0.0075 0.1005)
+(0.0000 -0.0075 0.1005)
+(0.0030 -0.0075 0.1005)
+(0.0060 -0.0075 0.1005)
+(-0.0060 -0.0045 0.1005)
+(-0.0030 -0.0045 0.1005)
+(0.0000 -0.0045 0.1005)
+(0.0030 -0.0045 0.1005)
+(0.0060 -0.0045 0.1005)
+(-0.0060 -0.0015 0.1005)
+(-0.0030 -0.0015 0.1005)
+(0.0000 -0.0015 0.1005)
+(0.0030 -0.0015 0.1005)
+(0.0060 -0.0015 0.1005)
+(-0.0060 0.0015 0.1005)
+(-0.0030 0.0015 0.1005)
+(0.0000 0.0015 0.1005)
+(0.0030 0.0015 0.1005)
+(0.0060 0.0015 0.1005)
+(-0.0060 0.0045 0.1005)
+(-0.0030 0.0045 0.1005)
+(0.0000 0.0045 0.1005)
+(0.0030 0.0045 0.1005)
+(0.0060 0.0045 0.1005)
+(-0.0060 0.0075 0.1005)
+(-0.0030 0.0075 0.1005)
+(0.0000 0.0075 0.1005)
+(0.0030 0.0075 0.1005)
+(0.0060 0.0075 0.1005)
+(-0.0060 0.0105 0.1005)
+(-0.0030 0.0105 0.1005)
+(0.0000 0.0105 0.1005)
+(0.0030 0.0105 0.1005)
+(0.0060 0.0105 0.1005)
+(-0.0060 0.0135 0.1005)
+(-0.0030 0.0135 0.1005)
+(0.0000 0.0135 0.1005)
+(0.0030 0.0135 0.1005)
+(0.0060 0.0135 0.1005)
+(-0.0060 0.0165 0.1005)
+(-0.0030 0.0165 0.1005)
+(0.0000 0.0165 0.1005)
+(0.0030 0.0165 0.1005)
+(0.0060 0.0165 0.1005)
+(-0.0060 0.0195 0.1005)
+(-0.0030 0.0195 0.1005)
+(0.0000 0.0195 0.1005)
+(0.0030 0.0195 0.1005)
+(0.0060 0.0195 0.1005)
+(-0.0060 0.0225 0.1005)
+(-0.0030 0.0225 0.1005)
+(0.0000 0.0225 0.1005)
+(0.0030 0.0225 0.1005)
+(0.0060 0.0225 0.1005)
+(-0.0060 0.0255 0.1005)
+(-0.0030 0.0255 0.1005)
+(0.0000 0.0255 0.1005)
+(0.0030 0.0255 0.1005)
+(0.0060 0.0255 0.1005)
+(-0.0060 0.0285 0.1005)
+(-0.0030 0.0285 0.1005)
+(0.0000 0.0285 0.1005)
+(0.0030 0.0285 0.1005)
+(0.0060 0.0285 0.1005)
+(-0.0060 0.0315 0.1005)
+(-0.0030 0.0315 0.1005)
+(0.0000 0.0315 0.1005)
+(0.0030 0.0315 0.1005)
+(0.0060 0.0315 0.1005)
+(-0.0060 0.0345 0.1005)
+(-0.0030 0.0345 0.1005)
+(0.0000 0.0345 0.1005)
+(0.0030 0.0345 0.1005)
+(0.0060 0.0345 0.1005)
+(-0.0060 0.0375 0.1005)
+(-0.0030 0.0375 0.1005)
+(0.0000 0.0375 0.1005)
+(0.0030 0.0375 0.1005)
+(0.0060 0.0375 0.1005)
+(-0.0060 0.0405 0.1005)
+(-0.0030 0.0405 0.1005)
+(0.0000 0.0405 0.1005)
+(0.0030 0.0405 0.1005)
+(0.0060 0.0405 0.1005)
+(-0.0060 0.0435 0.1005)
+(-0.0030 0.0435 0.1005)
+(0.0000 0.0435 0.1005)
+(0.0030 0.0435 0.1005)
+(0.0060 0.0435 0.1005)
+(-0.0060 0.0465 0.1005)
+(-0.0030 0.0465 0.1005)
+(0.0000 0.0465 0.1005)
+(0.0030 0.0465 0.1005)
+(0.0060 0.0465 0.1005)
+(-0.0060 0.0495 0.1005)
+(-0.0030 0.0495 0.1005)
+(0.0000 0.0495 0.1005)
+(0.0030 0.0495 0.1005)
+(0.0060 0.0495 0.1005)
+(-0.0060 0.0525 0.1005)
+(-0.0030 0.0525 0.1005)
+(0.0000 0.0525 0.1005)
+(0.0030 0.0525 0.1005)
+(0.0060 0.0525 0.1005)
+(-0.0060 0.0555 0.1005)
+(-0.0030 0.0555 0.1005)
+(0.0000 0.0555 0.1005)
+(0.0030 0.0555 0.1005)
+(0.0060 0.0555 0.1005)
+(-0.0060 0.0585 0.1005)
+(-0.0030 0.0585 0.1005)
+(0.0000 0.0585 0.1005)
+(0.0030 0.0585 0.1005)
+(0.0060 0.0585 0.1005)
+(-0.0060 0.0615 0.1005)
+(-0.0030 0.0615 0.1005)
+(0.0000 0.0615 0.1005)
+(0.0030 0.0615 0.1005)
+(0.0060 0.0615 0.1005)
+(-0.0060 0.0645 0.1005)
+(-0.0030 0.0645 0.1005)
+(0.0000 0.0645 0.1005)
+(0.0030 0.0645 0.1005)
+(0.0060 0.0645 0.1005)
+(-0.0060 0.0675 0.1005)
+(-0.0030 0.0675 0.1005)
+(0.0000 0.0675 0.1005)
+(0.0030 0.0675 0.1005)
+(0.0060 0.0675 0.1005)
+(-0.0060 0.0705 0.1005)
+(-0.0030 0.0705 0.1005)
+(0.0000 0.0705 0.1005)
+(0.0030 0.0705 0.1005)
+(0.0060 0.0705 0.1005)
+(-0.0060 0.0735 0.1005)
+(-0.0030 0.0735 0.1005)
+(0.0000 0.0735 0.1005)
+(0.0030 0.0735 0.1005)
+(0.0060 0.0735 0.1005)
+(-0.0060 -0.0735 0.1035)
+(-0.0030 -0.0735 0.1035)
+(0.0000 -0.0735 0.1035)
+(0.0030 -0.0735 0.1035)
+(0.0060 -0.0735 0.1035)
+(-0.0060 -0.0705 0.1035)
+(-0.0030 -0.0705 0.1035)
+(0.0000 -0.0705 0.1035)
+(0.0030 -0.0705 0.1035)
+(0.0060 -0.0705 0.1035)
+(-0.0060 -0.0675 0.1035)
+(-0.0030 -0.0675 0.1035)
+(0.0000 -0.0675 0.1035)
+(0.0030 -0.0675 0.1035)
+(0.0060 -0.0675 0.1035)
+(-0.0060 -0.0645 0.1035)
+(-0.0030 -0.0645 0.1035)
+(0.0000 -0.0645 0.1035)
+(0.0030 -0.0645 0.1035)
+(0.0060 -0.0645 0.1035)
+(-0.0060 -0.0615 0.1035)
+(-0.0030 -0.0615 0.1035)
+(0.0000 -0.0615 0.1035)
+(0.0030 -0.0615 0.1035)
+(0.0060 -0.0615 0.1035)
+(-0.0060 -0.0585 0.1035)
+(-0.0030 -0.0585 0.1035)
+(0.0000 -0.0585 0.1035)
+(0.0030 -0.0585 0.1035)
+(0.0060 -0.0585 0.1035)
+(-0.0060 -0.0555 0.1035)
+(-0.0030 -0.0555 0.1035)
+(0.0000 -0.0555 0.1035)
+(0.0030 -0.0555 0.1035)
+(0.0060 -0.0555 0.1035)
+(-0.0060 -0.0525 0.1035)
+(-0.0030 -0.0525 0.1035)
+(0.0000 -0.0525 0.1035)
+(0.0030 -0.0525 0.1035)
+(0.0060 -0.0525 0.1035)
+(-0.0060 -0.0495 0.1035)
+(-0.0030 -0.0495 0.1035)
+(0.0000 -0.0495 0.1035)
+(0.0030 -0.0495 0.1035)
+(0.0060 -0.0495 0.1035)
+(-0.0060 -0.0465 0.1035)
+(-0.0030 -0.0465 0.1035)
+(0.0000 -0.0465 0.1035)
+(0.0030 -0.0465 0.1035)
+(0.0060 -0.0465 0.1035)
+(-0.0060 -0.0435 0.1035)
+(-0.0030 -0.0435 0.1035)
+(0.0000 -0.0435 0.1035)
+(0.0030 -0.0435 0.1035)
+(0.0060 -0.0435 0.1035)
+(-0.0060 -0.0405 0.1035)
+(-0.0030 -0.0405 0.1035)
+(0.0000 -0.0405 0.1035)
+(0.0030 -0.0405 0.1035)
+(0.0060 -0.0405 0.1035)
+(-0.0060 -0.0375 0.1035)
+(-0.0030 -0.0375 0.1035)
+(0.0000 -0.0375 0.1035)
+(0.0030 -0.0375 0.1035)
+(0.0060 -0.0375 0.1035)
+(-0.0060 -0.0345 0.1035)
+(-0.0030 -0.0345 0.1035)
+(0.0000 -0.0345 0.1035)
+(0.0030 -0.0345 0.1035)
+(0.0060 -0.0345 0.1035)
+(-0.0060 -0.0315 0.1035)
+(-0.0030 -0.0315 0.1035)
+(0.0000 -0.0315 0.1035)
+(0.0030 -0.0315 0.1035)
+(0.0060 -0.0315 0.1035)
+(-0.0060 -0.0285 0.1035)
+(-0.0030 -0.0285 0.1035)
+(0.0000 -0.0285 0.1035)
+(0.0030 -0.0285 0.1035)
+(0.0060 -0.0285 0.1035)
+(-0.0060 -0.0255 0.1035)
+(-0.0030 -0.0255 0.1035)
+(0.0000 -0.0255 0.1035)
+(0.0030 -0.0255 0.1035)
+(0.0060 -0.0255 0.1035)
+(-0.0060 -0.0225 0.1035)
+(-0.0030 -0.0225 0.1035)
+(0.0000 -0.0225 0.1035)
+(0.0030 -0.0225 0.1035)
+(0.0060 -0.0225 0.1035)
+(-0.0060 -0.0195 0.1035)
+(-0.0030 -0.0195 0.1035)
+(0.0000 -0.0195 0.1035)
+(0.0030 -0.0195 0.1035)
+(0.0060 -0.0195 0.1035)
+(-0.0060 -0.0165 0.1035)
+(-0.0030 -0.0165 0.1035)
+(0.0000 -0.0165 0.1035)
+(0.0030 -0.0165 0.1035)
+(0.0060 -0.0165 0.1035)
+(-0.0060 -0.0135 0.1035)
+(-0.0030 -0.0135 0.1035)
+(0.0000 -0.0135 0.1035)
+(0.0030 -0.0135 0.1035)
+(0.0060 -0.0135 0.1035)
+(-0.0060 -0.0105 0.1035)
+(-0.0030 -0.0105 0.1035)
+(0.0000 -0.0105 0.1035)
+(0.0030 -0.0105 0.1035)
+(0.0060 -0.0105 0.1035)
+(-0.0060 -0.0075 0.1035)
+(-0.0030 -0.0075 0.1035)
+(0.0000 -0.0075 0.1035)
+(0.0030 -0.0075 0.1035)
+(0.0060 -0.0075 0.1035)
+(-0.0060 -0.0045 0.1035)
+(-0.0030 -0.0045 0.1035)
+(0.0000 -0.0045 0.1035)
+(0.0030 -0.0045 0.1035)
+(0.0060 -0.0045 0.1035)
+(-0.0060 -0.0015 0.1035)
+(-0.0030 -0.0015 0.1035)
+(0.0000 -0.0015 0.1035)
+(0.0030 -0.0015 0.1035)
+(0.0060 -0.0015 0.1035)
+(-0.0060 0.0015 0.1035)
+(-0.0030 0.0015 0.1035)
+(0.0000 0.0015 0.1035)
+(0.0030 0.0015 0.1035)
+(0.0060 0.0015 0.1035)
+(-0.0060 0.0045 0.1035)
+(-0.0030 0.0045 0.1035)
+(0.0000 0.0045 0.1035)
+(0.0030 0.0045 0.1035)
+(0.0060 0.0045 0.1035)
+(-0.0060 0.0075 0.1035)
+(-0.0030 0.0075 0.1035)
+(0.0000 0.0075 0.1035)
+(0.0030 0.0075 0.1035)
+(0.0060 0.0075 0.1035)
+(-0.0060 0.0105 0.1035)
+(-0.0030 0.0105 0.1035)
+(0.0000 0.0105 0.1035)
+(0.0030 0.0105 0.1035)
+(0.0060 0.0105 0.1035)
+(-0.0060 0.0135 0.1035)
+(-0.0030 0.0135 0.1035)
+(0.0000 0.0135 0.1035)
+(0.0030 0.0135 0.1035)
+(0.0060 0.0135 0.1035)
+(-0.0060 0.0165 0.1035)
+(-0.0030 0.0165 0.1035)
+(0.0000 0.0165 0.1035)
+(0.0030 0.0165 0.1035)
+(0.0060 0.0165 0.1035)
+(-0.0060 0.0195 0.1035)
+(-0.0030 0.0195 0.1035)
+(0.0000 0.0195 0.1035)
+(0.0030 0.0195 0.1035)
+(0.0060 0.0195 0.1035)
+(-0.0060 0.0225 0.1035)
+(-0.0030 0.0225 0.1035)
+(0.0000 0.0225 0.1035)
+(0.0030 0.0225 0.1035)
+(0.0060 0.0225 0.1035)
+(-0.0060 0.0255 0.1035)
+(-0.0030 0.0255 0.1035)
+(0.0000 0.0255 0.1035)
+(0.0030 0.0255 0.1035)
+(0.0060 0.0255 0.1035)
+(-0.0060 0.0285 0.1035)
+(-0.0030 0.0285 0.1035)
+(0.0000 0.0285 0.1035)
+(0.0030 0.0285 0.1035)
+(0.0060 0.0285 0.1035)
+(-0.0060 0.0315 0.1035)
+(-0.0030 0.0315 0.1035)
+(0.0000 0.0315 0.1035)
+(0.0030 0.0315 0.1035)
+(0.0060 0.0315 0.1035)
+(-0.0060 0.0345 0.1035)
+(-0.0030 0.0345 0.1035)
+(0.0000 0.0345 0.1035)
+(0.0030 0.0345 0.1035)
+(0.0060 0.0345 0.1035)
+(-0.0060 0.0375 0.1035)
+(-0.0030 0.0375 0.1035)
+(0.0000 0.0375 0.1035)
+(0.0030 0.0375 0.1035)
+(0.0060 0.0375 0.1035)
+(-0.0060 0.0405 0.1035)
+(-0.0030 0.0405 0.1035)
+(0.0000 0.0405 0.1035)
+(0.0030 0.0405 0.1035)
+(0.0060 0.0405 0.1035)
+(-0.0060 0.0435 0.1035)
+(-0.0030 0.0435 0.1035)
+(0.0000 0.0435 0.1035)
+(0.0030 0.0435 0.1035)
+(0.0060 0.0435 0.1035)
+(-0.0060 0.0465 0.1035)
+(-0.0030 0.0465 0.1035)
+(0.0000 0.0465 0.1035)
+(0.0030 0.0465 0.1035)
+(0.0060 0.0465 0.1035)
+(-0.0060 0.0495 0.1035)
+(-0.0030 0.0495 0.1035)
+(0.0000 0.0495 0.1035)
+(0.0030 0.0495 0.1035)
+(0.0060 0.0495 0.1035)
+(-0.0060 0.0525 0.1035)
+(-0.0030 0.0525 0.1035)
+(0.0000 0.0525 0.1035)
+(0.0030 0.0525 0.1035)
+(0.0060 0.0525 0.1035)
+(-0.0060 0.0555 0.1035)
+(-0.0030 0.0555 0.1035)
+(0.0000 0.0555 0.1035)
+(0.0030 0.0555 0.1035)
+(0.0060 0.0555 0.1035)
+(-0.0060 0.0585 0.1035)
+(-0.0030 0.0585 0.1035)
+(0.0000 0.0585 0.1035)
+(0.0030 0.0585 0.1035)
+(0.0060 0.0585 0.1035)
+(-0.0060 0.0615 0.1035)
+(-0.0030 0.0615 0.1035)
+(0.0000 0.0615 0.1035)
+(0.0030 0.0615 0.1035)
+(0.0060 0.0615 0.1035)
+(-0.0060 0.0645 0.1035)
+(-0.0030 0.0645 0.1035)
+(0.0000 0.0645 0.1035)
+(0.0030 0.0645 0.1035)
+(0.0060 0.0645 0.1035)
+(-0.0060 0.0675 0.1035)
+(-0.0030 0.0675 0.1035)
+(0.0000 0.0675 0.1035)
+(0.0030 0.0675 0.1035)
+(0.0060 0.0675 0.1035)
+(-0.0060 0.0705 0.1035)
+(-0.0030 0.0705 0.1035)
+(0.0000 0.0705 0.1035)
+(0.0030 0.0705 0.1035)
+(0.0060 0.0705 0.1035)
+(-0.0060 0.0735 0.1035)
+(-0.0030 0.0735 0.1035)
+(0.0000 0.0735 0.1035)
+(0.0030 0.0735 0.1035)
+(0.0060 0.0735 0.1035)
+(-0.0060 -0.0735 0.1065)
+(-0.0030 -0.0735 0.1065)
+(0.0000 -0.0735 0.1065)
+(0.0030 -0.0735 0.1065)
+(0.0060 -0.0735 0.1065)
+(-0.0060 -0.0705 0.1065)
+(-0.0030 -0.0705 0.1065)
+(0.0000 -0.0705 0.1065)
+(0.0030 -0.0705 0.1065)
+(0.0060 -0.0705 0.1065)
+(-0.0060 -0.0675 0.1065)
+(-0.0030 -0.0675 0.1065)
+(0.0000 -0.0675 0.1065)
+(0.0030 -0.0675 0.1065)
+(0.0060 -0.0675 0.1065)
+(-0.0060 -0.0645 0.1065)
+(-0.0030 -0.0645 0.1065)
+(0.0000 -0.0645 0.1065)
+(0.0030 -0.0645 0.1065)
+(0.0060 -0.0645 0.1065)
+(-0.0060 -0.0615 0.1065)
+(-0.0030 -0.0615 0.1065)
+(0.0000 -0.0615 0.1065)
+(0.0030 -0.0615 0.1065)
+(0.0060 -0.0615 0.1065)
+(-0.0060 -0.0585 0.1065)
+(-0.0030 -0.0585 0.1065)
+(0.0000 -0.0585 0.1065)
+(0.0030 -0.0585 0.1065)
+(0.0060 -0.0585 0.1065)
+(-0.0060 -0.0555 0.1065)
+(-0.0030 -0.0555 0.1065)
+(0.0000 -0.0555 0.1065)
+(0.0030 -0.0555 0.1065)
+(0.0060 -0.0555 0.1065)
+(-0.0060 -0.0525 0.1065)
+(-0.0030 -0.0525 0.1065)
+(0.0000 -0.0525 0.1065)
+(0.0030 -0.0525 0.1065)
+(0.0060 -0.0525 0.1065)
+(-0.0060 -0.0495 0.1065)
+(-0.0030 -0.0495 0.1065)
+(0.0000 -0.0495 0.1065)
+(0.0030 -0.0495 0.1065)
+(0.0060 -0.0495 0.1065)
+(-0.0060 -0.0465 0.1065)
+(-0.0030 -0.0465 0.1065)
+(0.0000 -0.0465 0.1065)
+(0.0030 -0.0465 0.1065)
+(0.0060 -0.0465 0.1065)
+(-0.0060 -0.0435 0.1065)
+(-0.0030 -0.0435 0.1065)
+(0.0000 -0.0435 0.1065)
+(0.0030 -0.0435 0.1065)
+(0.0060 -0.0435 0.1065)
+(-0.0060 -0.0405 0.1065)
+(-0.0030 -0.0405 0.1065)
+(0.0000 -0.0405 0.1065)
+(0.0030 -0.0405 0.1065)
+(0.0060 -0.0405 0.1065)
+(-0.0060 -0.0375 0.1065)
+(-0.0030 -0.0375 0.1065)
+(0.0000 -0.0375 0.1065)
+(0.0030 -0.0375 0.1065)
+(0.0060 -0.0375 0.1065)
+(-0.0060 -0.0345 0.1065)
+(-0.0030 -0.0345 0.1065)
+(0.0000 -0.0345 0.1065)
+(0.0030 -0.0345 0.1065)
+(0.0060 -0.0345 0.1065)
+(-0.0060 -0.0315 0.1065)
+(-0.0030 -0.0315 0.1065)
+(0.0000 -0.0315 0.1065)
+(0.0030 -0.0315 0.1065)
+(0.0060 -0.0315 0.1065)
+(-0.0060 -0.0285 0.1065)
+(-0.0030 -0.0285 0.1065)
+(0.0000 -0.0285 0.1065)
+(0.0030 -0.0285 0.1065)
+(0.0060 -0.0285 0.1065)
+(-0.0060 -0.0255 0.1065)
+(-0.0030 -0.0255 0.1065)
+(0.0000 -0.0255 0.1065)
+(0.0030 -0.0255 0.1065)
+(0.0060 -0.0255 0.1065)
+(-0.0060 -0.0225 0.1065)
+(-0.0030 -0.0225 0.1065)
+(0.0000 -0.0225 0.1065)
+(0.0030 -0.0225 0.1065)
+(0.0060 -0.0225 0.1065)
+(-0.0060 -0.0195 0.1065)
+(-0.0030 -0.0195 0.1065)
+(0.0000 -0.0195 0.1065)
+(0.0030 -0.0195 0.1065)
+(0.0060 -0.0195 0.1065)
+(-0.0060 -0.0165 0.1065)
+(-0.0030 -0.0165 0.1065)
+(0.0000 -0.0165 0.1065)
+(0.0030 -0.0165 0.1065)
+(0.0060 -0.0165 0.1065)
+(-0.0060 -0.0135 0.1065)
+(-0.0030 -0.0135 0.1065)
+(0.0000 -0.0135 0.1065)
+(0.0030 -0.0135 0.1065)
+(0.0060 -0.0135 0.1065)
+(-0.0060 -0.0105 0.1065)
+(-0.0030 -0.0105 0.1065)
+(0.0000 -0.0105 0.1065)
+(0.0030 -0.0105 0.1065)
+(0.0060 -0.0105 0.1065)
+(-0.0060 -0.0075 0.1065)
+(-0.0030 -0.0075 0.1065)
+(0.0000 -0.0075 0.1065)
+(0.0030 -0.0075 0.1065)
+(0.0060 -0.0075 0.1065)
+(-0.0060 -0.0045 0.1065)
+(-0.0030 -0.0045 0.1065)
+(0.0000 -0.0045 0.1065)
+(0.0030 -0.0045 0.1065)
+(0.0060 -0.0045 0.1065)
+(-0.0060 -0.0015 0.1065)
+(-0.0030 -0.0015 0.1065)
+(0.0000 -0.0015 0.1065)
+(0.0030 -0.0015 0.1065)
+(0.0060 -0.0015 0.1065)
+(-0.0060 0.0015 0.1065)
+(-0.0030 0.0015 0.1065)
+(0.0000 0.0015 0.1065)
+(0.0030 0.0015 0.1065)
+(0.0060 0.0015 0.1065)
+(-0.0060 0.0045 0.1065)
+(-0.0030 0.0045 0.1065)
+(0.0000 0.0045 0.1065)
+(0.0030 0.0045 0.1065)
+(0.0060 0.0045 0.1065)
+(-0.0060 0.0075 0.1065)
+(-0.0030 0.0075 0.1065)
+(0.0000 0.0075 0.1065)
+(0.0030 0.0075 0.1065)
+(0.0060 0.0075 0.1065)
+(-0.0060 0.0105 0.1065)
+(-0.0030 0.0105 0.1065)
+(0.0000 0.0105 0.1065)
+(0.0030 0.0105 0.1065)
+(0.0060 0.0105 0.1065)
+(-0.0060 0.0135 0.1065)
+(-0.0030 0.0135 0.1065)
+(0.0000 0.0135 0.1065)
+(0.0030 0.0135 0.1065)
+(0.0060 0.0135 0.1065)
+(-0.0060 0.0165 0.1065)
+(-0.0030 0.0165 0.1065)
+(0.0000 0.0165 0.1065)
+(0.0030 0.0165 0.1065)
+(0.0060 0.0165 0.1065)
+(-0.0060 0.0195 0.1065)
+(-0.0030 0.0195 0.1065)
+(0.0000 0.0195 0.1065)
+(0.0030 0.0195 0.1065)
+(0.0060 0.0195 0.1065)
+(-0.0060 0.0225 0.1065)
+(-0.0030 0.0225 0.1065)
+(0.0000 0.0225 0.1065)
+(0.0030 0.0225 0.1065)
+(0.0060 0.0225 0.1065)
+(-0.0060 0.0255 0.1065)
+(-0.0030 0.0255 0.1065)
+(0.0000 0.0255 0.1065)
+(0.0030 0.0255 0.1065)
+(0.0060 0.0255 0.1065)
+(-0.0060 0.0285 0.1065)
+(-0.0030 0.0285 0.1065)
+(0.0000 0.0285 0.1065)
+(0.0030 0.0285 0.1065)
+(0.0060 0.0285 0.1065)
+(-0.0060 0.0315 0.1065)
+(-0.0030 0.0315 0.1065)
+(0.0000 0.0315 0.1065)
+(0.0030 0.0315 0.1065)
+(0.0060 0.0315 0.1065)
+(-0.0060 0.0345 0.1065)
+(-0.0030 0.0345 0.1065)
+(0.0000 0.0345 0.1065)
+(0.0030 0.0345 0.1065)
+(0.0060 0.0345 0.1065)
+(-0.0060 0.0375 0.1065)
+(-0.0030 0.0375 0.1065)
+(0.0000 0.0375 0.1065)
+(0.0030 0.0375 0.1065)
+(0.0060 0.0375 0.1065)
+(-0.0060 0.0405 0.1065)
+(-0.0030 0.0405 0.1065)
+(0.0000 0.0405 0.1065)
+(0.0030 0.0405 0.1065)
+(0.0060 0.0405 0.1065)
+(-0.0060 0.0435 0.1065)
+(-0.0030 0.0435 0.1065)
+(0.0000 0.0435 0.1065)
+(0.0030 0.0435 0.1065)
+(0.0060 0.0435 0.1065)
+(-0.0060 0.0465 0.1065)
+(-0.0030 0.0465 0.1065)
+(0.0000 0.0465 0.1065)
+(0.0030 0.0465 0.1065)
+(0.0060 0.0465 0.1065)
+(-0.0060 0.0495 0.1065)
+(-0.0030 0.0495 0.1065)
+(0.0000 0.0495 0.1065)
+(0.0030 0.0495 0.1065)
+(0.0060 0.0495 0.1065)
+(-0.0060 0.0525 0.1065)
+(-0.0030 0.0525 0.1065)
+(0.0000 0.0525 0.1065)
+(0.0030 0.0525 0.1065)
+(0.0060 0.0525 0.1065)
+(-0.0060 0.0555 0.1065)
+(-0.0030 0.0555 0.1065)
+(0.0000 0.0555 0.1065)
+(0.0030 0.0555 0.1065)
+(0.0060 0.0555 0.1065)
+(-0.0060 0.0585 0.1065)
+(-0.0030 0.0585 0.1065)
+(0.0000 0.0585 0.1065)
+(0.0030 0.0585 0.1065)
+(0.0060 0.0585 0.1065)
+(-0.0060 0.0615 0.1065)
+(-0.0030 0.0615 0.1065)
+(0.0000 0.0615 0.1065)
+(0.0030 0.0615 0.1065)
+(0.0060 0.0615 0.1065)
+(-0.0060 0.0645 0.1065)
+(-0.0030 0.0645 0.1065)
+(0.0000 0.0645 0.1065)
+(0.0030 0.0645 0.1065)
+(0.0060 0.0645 0.1065)
+(-0.0060 0.0675 0.1065)
+(-0.0030 0.0675 0.1065)
+(0.0000 0.0675 0.1065)
+(0.0030 0.0675 0.1065)
+(0.0060 0.0675 0.1065)
+(-0.0060 0.0705 0.1065)
+(-0.0030 0.0705 0.1065)
+(0.0000 0.0705 0.1065)
+(0.0030 0.0705 0.1065)
+(0.0060 0.0705 0.1065)
+(-0.0060 0.0735 0.1065)
+(-0.0030 0.0735 0.1065)
+(0.0000 0.0735 0.1065)
+(0.0030 0.0735 0.1065)
+(0.0060 0.0735 0.1065)
+(-0.0060 -0.0735 0.1095)
+(-0.0030 -0.0735 0.1095)
+(0.0000 -0.0735 0.1095)
+(0.0030 -0.0735 0.1095)
+(0.0060 -0.0735 0.1095)
+(-0.0060 -0.0705 0.1095)
+(-0.0030 -0.0705 0.1095)
+(0.0000 -0.0705 0.1095)
+(0.0030 -0.0705 0.1095)
+(0.0060 -0.0705 0.1095)
+(-0.0060 -0.0675 0.1095)
+(-0.0030 -0.0675 0.1095)
+(0.0000 -0.0675 0.1095)
+(0.0030 -0.0675 0.1095)
+(0.0060 -0.0675 0.1095)
+(-0.0060 -0.0645 0.1095)
+(-0.0030 -0.0645 0.1095)
+(0.0000 -0.0645 0.1095)
+(0.0030 -0.0645 0.1095)
+(0.0060 -0.0645 0.1095)
+(-0.0060 -0.0615 0.1095)
+(-0.0030 -0.0615 0.1095)
+(0.0000 -0.0615 0.1095)
+(0.0030 -0.0615 0.1095)
+(0.0060 -0.0615 0.1095)
+(-0.0060 -0.0585 0.1095)
+(-0.0030 -0.0585 0.1095)
+(0.0000 -0.0585 0.1095)
+(0.0030 -0.0585 0.1095)
+(0.0060 -0.0585 0.1095)
+(-0.0060 -0.0555 0.1095)
+(-0.0030 -0.0555 0.1095)
+(0.0000 -0.0555 0.1095)
+(0.0030 -0.0555 0.1095)
+(0.0060 -0.0555 0.1095)
+(-0.0060 -0.0525 0.1095)
+(-0.0030 -0.0525 0.1095)
+(0.0000 -0.0525 0.1095)
+(0.0030 -0.0525 0.1095)
+(0.0060 -0.0525 0.1095)
+(-0.0060 -0.0495 0.1095)
+(-0.0030 -0.0495 0.1095)
+(0.0000 -0.0495 0.1095)
+(0.0030 -0.0495 0.1095)
+(0.0060 -0.0495 0.1095)
+(-0.0060 -0.0465 0.1095)
+(-0.0030 -0.0465 0.1095)
+(0.0000 -0.0465 0.1095)
+(0.0030 -0.0465 0.1095)
+(0.0060 -0.0465 0.1095)
+(-0.0060 -0.0435 0.1095)
+(-0.0030 -0.0435 0.1095)
+(0.0000 -0.0435 0.1095)
+(0.0030 -0.0435 0.1095)
+(0.0060 -0.0435 0.1095)
+(-0.0060 -0.0405 0.1095)
+(-0.0030 -0.0405 0.1095)
+(0.0000 -0.0405 0.1095)
+(0.0030 -0.0405 0.1095)
+(0.0060 -0.0405 0.1095)
+(-0.0060 -0.0375 0.1095)
+(-0.0030 -0.0375 0.1095)
+(0.0000 -0.0375 0.1095)
+(0.0030 -0.0375 0.1095)
+(0.0060 -0.0375 0.1095)
+(-0.0060 -0.0345 0.1095)
+(-0.0030 -0.0345 0.1095)
+(0.0000 -0.0345 0.1095)
+(0.0030 -0.0345 0.1095)
+(0.0060 -0.0345 0.1095)
+(-0.0060 -0.0315 0.1095)
+(-0.0030 -0.0315 0.1095)
+(0.0000 -0.0315 0.1095)
+(0.0030 -0.0315 0.1095)
+(0.0060 -0.0315 0.1095)
+(-0.0060 -0.0285 0.1095)
+(-0.0030 -0.0285 0.1095)
+(0.0000 -0.0285 0.1095)
+(0.0030 -0.0285 0.1095)
+(0.0060 -0.0285 0.1095)
+(-0.0060 -0.0255 0.1095)
+(-0.0030 -0.0255 0.1095)
+(0.0000 -0.0255 0.1095)
+(0.0030 -0.0255 0.1095)
+(0.0060 -0.0255 0.1095)
+(-0.0060 -0.0225 0.1095)
+(-0.0030 -0.0225 0.1095)
+(0.0000 -0.0225 0.1095)
+(0.0030 -0.0225 0.1095)
+(0.0060 -0.0225 0.1095)
+(-0.0060 -0.0195 0.1095)
+(-0.0030 -0.0195 0.1095)
+(0.0000 -0.0195 0.1095)
+(0.0030 -0.0195 0.1095)
+(0.0060 -0.0195 0.1095)
+(-0.0060 -0.0165 0.1095)
+(-0.0030 -0.0165 0.1095)
+(0.0000 -0.0165 0.1095)
+(0.0030 -0.0165 0.1095)
+(0.0060 -0.0165 0.1095)
+(-0.0060 -0.0135 0.1095)
+(-0.0030 -0.0135 0.1095)
+(0.0000 -0.0135 0.1095)
+(0.0030 -0.0135 0.1095)
+(0.0060 -0.0135 0.1095)
+(-0.0060 -0.0105 0.1095)
+(-0.0030 -0.0105 0.1095)
+(0.0000 -0.0105 0.1095)
+(0.0030 -0.0105 0.1095)
+(0.0060 -0.0105 0.1095)
+(-0.0060 -0.0075 0.1095)
+(-0.0030 -0.0075 0.1095)
+(0.0000 -0.0075 0.1095)
+(0.0030 -0.0075 0.1095)
+(0.0060 -0.0075 0.1095)
+(-0.0060 -0.0045 0.1095)
+(-0.0030 -0.0045 0.1095)
+(0.0000 -0.0045 0.1095)
+(0.0030 -0.0045 0.1095)
+(0.0060 -0.0045 0.1095)
+(-0.0060 -0.0015 0.1095)
+(-0.0030 -0.0015 0.1095)
+(0.0000 -0.0015 0.1095)
+(0.0030 -0.0015 0.1095)
+(0.0060 -0.0015 0.1095)
+(-0.0060 0.0015 0.1095)
+(-0.0030 0.0015 0.1095)
+(0.0000 0.0015 0.1095)
+(0.0030 0.0015 0.1095)
+(0.0060 0.0015 0.1095)
+(-0.0060 0.0045 0.1095)
+(-0.0030 0.0045 0.1095)
+(0.0000 0.0045 0.1095)
+(0.0030 0.0045 0.1095)
+(0.0060 0.0045 0.1095)
+(-0.0060 0.0075 0.1095)
+(-0.0030 0.0075 0.1095)
+(0.0000 0.0075 0.1095)
+(0.0030 0.0075 0.1095)
+(0.0060 0.0075 0.1095)
+(-0.0060 0.0105 0.1095)
+(-0.0030 0.0105 0.1095)
+(0.0000 0.0105 0.1095)
+(0.0030 0.0105 0.1095)
+(0.0060 0.0105 0.1095)
+(-0.0060 0.0135 0.1095)
+(-0.0030 0.0135 0.1095)
+(0.0000 0.0135 0.1095)
+(0.0030 0.0135 0.1095)
+(0.0060 0.0135 0.1095)
+(-0.0060 0.0165 0.1095)
+(-0.0030 0.0165 0.1095)
+(0.0000 0.0165 0.1095)
+(0.0030 0.0165 0.1095)
+(0.0060 0.0165 0.1095)
+(-0.0060 0.0195 0.1095)
+(-0.0030 0.0195 0.1095)
+(0.0000 0.0195 0.1095)
+(0.0030 0.0195 0.1095)
+(0.0060 0.0195 0.1095)
+(-0.0060 0.0225 0.1095)
+(-0.0030 0.0225 0.1095)
+(0.0000 0.0225 0.1095)
+(0.0030 0.0225 0.1095)
+(0.0060 0.0225 0.1095)
+(-0.0060 0.0255 0.1095)
+(-0.0030 0.0255 0.1095)
+(0.0000 0.0255 0.1095)
+(0.0030 0.0255 0.1095)
+(0.0060 0.0255 0.1095)
+(-0.0060 0.0285 0.1095)
+(-0.0030 0.0285 0.1095)
+(0.0000 0.0285 0.1095)
+(0.0030 0.0285 0.1095)
+(0.0060 0.0285 0.1095)
+(-0.0060 0.0315 0.1095)
+(-0.0030 0.0315 0.1095)
+(0.0000 0.0315 0.1095)
+(0.0030 0.0315 0.1095)
+(0.0060 0.0315 0.1095)
+(-0.0060 0.0345 0.1095)
+(-0.0030 0.0345 0.1095)
+(0.0000 0.0345 0.1095)
+(0.0030 0.0345 0.1095)
+(0.0060 0.0345 0.1095)
+(-0.0060 0.0375 0.1095)
+(-0.0030 0.0375 0.1095)
+(0.0000 0.0375 0.1095)
+(0.0030 0.0375 0.1095)
+(0.0060 0.0375 0.1095)
+(-0.0060 0.0405 0.1095)
+(-0.0030 0.0405 0.1095)
+(0.0000 0.0405 0.1095)
+(0.0030 0.0405 0.1095)
+(0.0060 0.0405 0.1095)
+(-0.0060 0.0435 0.1095)
+(-0.0030 0.0435 0.1095)
+(0.0000 0.0435 0.1095)
+(0.0030 0.0435 0.1095)
+(0.0060 0.0435 0.1095)
+(-0.0060 0.0465 0.1095)
+(-0.0030 0.0465 0.1095)
+(0.0000 0.0465 0.1095)
+(0.0030 0.0465 0.1095)
+(0.0060 0.0465 0.1095)
+(-0.0060 0.0495 0.1095)
+(-0.0030 0.0495 0.1095)
+(0.0000 0.0495 0.1095)
+(0.0030 0.0495 0.1095)
+(0.0060 0.0495 0.1095)
+(-0.0060 0.0525 0.1095)
+(-0.0030 0.0525 0.1095)
+(0.0000 0.0525 0.1095)
+(0.0030 0.0525 0.1095)
+(0.0060 0.0525 0.1095)
+(-0.0060 0.0555 0.1095)
+(-0.0030 0.0555 0.1095)
+(0.0000 0.0555 0.1095)
+(0.0030 0.0555 0.1095)
+(0.0060 0.0555 0.1095)
+(-0.0060 0.0585 0.1095)
+(-0.0030 0.0585 0.1095)
+(0.0000 0.0585 0.1095)
+(0.0030 0.0585 0.1095)
+(0.0060 0.0585 0.1095)
+(-0.0060 0.0615 0.1095)
+(-0.0030 0.0615 0.1095)
+(0.0000 0.0615 0.1095)
+(0.0030 0.0615 0.1095)
+(0.0060 0.0615 0.1095)
+(-0.0060 0.0645 0.1095)
+(-0.0030 0.0645 0.1095)
+(0.0000 0.0645 0.1095)
+(0.0030 0.0645 0.1095)
+(0.0060 0.0645 0.1095)
+(-0.0060 0.0675 0.1095)
+(-0.0030 0.0675 0.1095)
+(0.0000 0.0675 0.1095)
+(0.0030 0.0675 0.1095)
+(0.0060 0.0675 0.1095)
+(-0.0060 0.0705 0.1095)
+(-0.0030 0.0705 0.1095)
+(0.0000 0.0705 0.1095)
+(0.0030 0.0705 0.1095)
+(0.0060 0.0705 0.1095)
+(-0.0060 0.0735 0.1095)
+(-0.0030 0.0735 0.1095)
+(0.0000 0.0735 0.1095)
+(0.0030 0.0735 0.1095)
+(0.0060 0.0735 0.1095)
+(-0.0060 -0.0735 0.1125)
+(-0.0030 -0.0735 0.1125)
+(0.0000 -0.0735 0.1125)
+(0.0030 -0.0735 0.1125)
+(0.0060 -0.0735 0.1125)
+(-0.0060 -0.0705 0.1125)
+(-0.0030 -0.0705 0.1125)
+(0.0000 -0.0705 0.1125)
+(0.0030 -0.0705 0.1125)
+(0.0060 -0.0705 0.1125)
+(-0.0060 -0.0675 0.1125)
+(-0.0030 -0.0675 0.1125)
+(0.0000 -0.0675 0.1125)
+(0.0030 -0.0675 0.1125)
+(0.0060 -0.0675 0.1125)
+(-0.0060 -0.0645 0.1125)
+(-0.0030 -0.0645 0.1125)
+(0.0000 -0.0645 0.1125)
+(0.0030 -0.0645 0.1125)
+(0.0060 -0.0645 0.1125)
+(-0.0060 -0.0615 0.1125)
+(-0.0030 -0.0615 0.1125)
+(0.0000 -0.0615 0.1125)
+(0.0030 -0.0615 0.1125)
+(0.0060 -0.0615 0.1125)
+(-0.0060 -0.0585 0.1125)
+(-0.0030 -0.0585 0.1125)
+(0.0000 -0.0585 0.1125)
+(0.0030 -0.0585 0.1125)
+(0.0060 -0.0585 0.1125)
+(-0.0060 -0.0555 0.1125)
+(-0.0030 -0.0555 0.1125)
+(0.0000 -0.0555 0.1125)
+(0.0030 -0.0555 0.1125)
+(0.0060 -0.0555 0.1125)
+(-0.0060 -0.0525 0.1125)
+(-0.0030 -0.0525 0.1125)
+(0.0000 -0.0525 0.1125)
+(0.0030 -0.0525 0.1125)
+(0.0060 -0.0525 0.1125)
+(-0.0060 -0.0495 0.1125)
+(-0.0030 -0.0495 0.1125)
+(0.0000 -0.0495 0.1125)
+(0.0030 -0.0495 0.1125)
+(0.0060 -0.0495 0.1125)
+(-0.0060 -0.0465 0.1125)
+(-0.0030 -0.0465 0.1125)
+(0.0000 -0.0465 0.1125)
+(0.0030 -0.0465 0.1125)
+(0.0060 -0.0465 0.1125)
+(-0.0060 -0.0435 0.1125)
+(-0.0030 -0.0435 0.1125)
+(0.0000 -0.0435 0.1125)
+(0.0030 -0.0435 0.1125)
+(0.0060 -0.0435 0.1125)
+(-0.0060 -0.0405 0.1125)
+(-0.0030 -0.0405 0.1125)
+(0.0000 -0.0405 0.1125)
+(0.0030 -0.0405 0.1125)
+(0.0060 -0.0405 0.1125)
+(-0.0060 -0.0375 0.1125)
+(-0.0030 -0.0375 0.1125)
+(0.0000 -0.0375 0.1125)
+(0.0030 -0.0375 0.1125)
+(0.0060 -0.0375 0.1125)
+(-0.0060 -0.0345 0.1125)
+(-0.0030 -0.0345 0.1125)
+(0.0000 -0.0345 0.1125)
+(0.0030 -0.0345 0.1125)
+(0.0060 -0.0345 0.1125)
+(-0.0060 -0.0315 0.1125)
+(-0.0030 -0.0315 0.1125)
+(0.0000 -0.0315 0.1125)
+(0.0030 -0.0315 0.1125)
+(0.0060 -0.0315 0.1125)
+(-0.0060 -0.0285 0.1125)
+(-0.0030 -0.0285 0.1125)
+(0.0000 -0.0285 0.1125)
+(0.0030 -0.0285 0.1125)
+(0.0060 -0.0285 0.1125)
+(-0.0060 -0.0255 0.1125)
+(-0.0030 -0.0255 0.1125)
+(0.0000 -0.0255 0.1125)
+(0.0030 -0.0255 0.1125)
+(0.0060 -0.0255 0.1125)
+(-0.0060 -0.0225 0.1125)
+(-0.0030 -0.0225 0.1125)
+(0.0000 -0.0225 0.1125)
+(0.0030 -0.0225 0.1125)
+(0.0060 -0.0225 0.1125)
+(-0.0060 -0.0195 0.1125)
+(-0.0030 -0.0195 0.1125)
+(0.0000 -0.0195 0.1125)
+(0.0030 -0.0195 0.1125)
+(0.0060 -0.0195 0.1125)
+(-0.0060 -0.0165 0.1125)
+(-0.0030 -0.0165 0.1125)
+(0.0000 -0.0165 0.1125)
+(0.0030 -0.0165 0.1125)
+(0.0060 -0.0165 0.1125)
+(-0.0060 -0.0135 0.1125)
+(-0.0030 -0.0135 0.1125)
+(0.0000 -0.0135 0.1125)
+(0.0030 -0.0135 0.1125)
+(0.0060 -0.0135 0.1125)
+(-0.0060 -0.0105 0.1125)
+(-0.0030 -0.0105 0.1125)
+(0.0000 -0.0105 0.1125)
+(0.0030 -0.0105 0.1125)
+(0.0060 -0.0105 0.1125)
+(-0.0060 -0.0075 0.1125)
+(-0.0030 -0.0075 0.1125)
+(0.0000 -0.0075 0.1125)
+(0.0030 -0.0075 0.1125)
+(0.0060 -0.0075 0.1125)
+(-0.0060 -0.0045 0.1125)
+(-0.0030 -0.0045 0.1125)
+(0.0000 -0.0045 0.1125)
+(0.0030 -0.0045 0.1125)
+(0.0060 -0.0045 0.1125)
+(-0.0060 -0.0015 0.1125)
+(-0.0030 -0.0015 0.1125)
+(0.0000 -0.0015 0.1125)
+(0.0030 -0.0015 0.1125)
+(0.0060 -0.0015 0.1125)
+(-0.0060 0.0015 0.1125)
+(-0.0030 0.0015 0.1125)
+(0.0000 0.0015 0.1125)
+(0.0030 0.0015 0.1125)
+(0.0060 0.0015 0.1125)
+(-0.0060 0.0045 0.1125)
+(-0.0030 0.0045 0.1125)
+(0.0000 0.0045 0.1125)
+(0.0030 0.0045 0.1125)
+(0.0060 0.0045 0.1125)
+(-0.0060 0.0075 0.1125)
+(-0.0030 0.0075 0.1125)
+(0.0000 0.0075 0.1125)
+(0.0030 0.0075 0.1125)
+(0.0060 0.0075 0.1125)
+(-0.0060 0.0105 0.1125)
+(-0.0030 0.0105 0.1125)
+(0.0000 0.0105 0.1125)
+(0.0030 0.0105 0.1125)
+(0.0060 0.0105 0.1125)
+(-0.0060 0.0135 0.1125)
+(-0.0030 0.0135 0.1125)
+(0.0000 0.0135 0.1125)
+(0.0030 0.0135 0.1125)
+(0.0060 0.0135 0.1125)
+(-0.0060 0.0165 0.1125)
+(-0.0030 0.0165 0.1125)
+(0.0000 0.0165 0.1125)
+(0.0030 0.0165 0.1125)
+(0.0060 0.0165 0.1125)
+(-0.0060 0.0195 0.1125)
+(-0.0030 0.0195 0.1125)
+(0.0000 0.0195 0.1125)
+(0.0030 0.0195 0.1125)
+(0.0060 0.0195 0.1125)
+(-0.0060 0.0225 0.1125)
+(-0.0030 0.0225 0.1125)
+(0.0000 0.0225 0.1125)
+(0.0030 0.0225 0.1125)
+(0.0060 0.0225 0.1125)
+(-0.0060 0.0255 0.1125)
+(-0.0030 0.0255 0.1125)
+(0.0000 0.0255 0.1125)
+(0.0030 0.0255 0.1125)
+(0.0060 0.0255 0.1125)
+(-0.0060 0.0285 0.1125)
+(-0.0030 0.0285 0.1125)
+(0.0000 0.0285 0.1125)
+(0.0030 0.0285 0.1125)
+(0.0060 0.0285 0.1125)
+(-0.0060 0.0315 0.1125)
+(-0.0030 0.0315 0.1125)
+(0.0000 0.0315 0.1125)
+(0.0030 0.0315 0.1125)
+(0.0060 0.0315 0.1125)
+(-0.0060 0.0345 0.1125)
+(-0.0030 0.0345 0.1125)
+(0.0000 0.0345 0.1125)
+(0.0030 0.0345 0.1125)
+(0.0060 0.0345 0.1125)
+(-0.0060 0.0375 0.1125)
+(-0.0030 0.0375 0.1125)
+(0.0000 0.0375 0.1125)
+(0.0030 0.0375 0.1125)
+(0.0060 0.0375 0.1125)
+(-0.0060 0.0405 0.1125)
+(-0.0030 0.0405 0.1125)
+(0.0000 0.0405 0.1125)
+(0.0030 0.0405 0.1125)
+(0.0060 0.0405 0.1125)
+(-0.0060 0.0435 0.1125)
+(-0.0030 0.0435 0.1125)
+(0.0000 0.0435 0.1125)
+(0.0030 0.0435 0.1125)
+(0.0060 0.0435 0.1125)
+(-0.0060 0.0465 0.1125)
+(-0.0030 0.0465 0.1125)
+(0.0000 0.0465 0.1125)
+(0.0030 0.0465 0.1125)
+(0.0060 0.0465 0.1125)
+(-0.0060 0.0495 0.1125)
+(-0.0030 0.0495 0.1125)
+(0.0000 0.0495 0.1125)
+(0.0030 0.0495 0.1125)
+(0.0060 0.0495 0.1125)
+(-0.0060 0.0525 0.1125)
+(-0.0030 0.0525 0.1125)
+(0.0000 0.0525 0.1125)
+(0.0030 0.0525 0.1125)
+(0.0060 0.0525 0.1125)
+(-0.0060 0.0555 0.1125)
+(-0.0030 0.0555 0.1125)
+(0.0000 0.0555 0.1125)
+(0.0030 0.0555 0.1125)
+(0.0060 0.0555 0.1125)
+(-0.0060 0.0585 0.1125)
+(-0.0030 0.0585 0.1125)
+(0.0000 0.0585 0.1125)
+(0.0030 0.0585 0.1125)
+(0.0060 0.0585 0.1125)
+(-0.0060 0.0615 0.1125)
+(-0.0030 0.0615 0.1125)
+(0.0000 0.0615 0.1125)
+(0.0030 0.0615 0.1125)
+(0.0060 0.0615 0.1125)
+(-0.0060 0.0645 0.1125)
+(-0.0030 0.0645 0.1125)
+(0.0000 0.0645 0.1125)
+(0.0030 0.0645 0.1125)
+(0.0060 0.0645 0.1125)
+(-0.0060 0.0675 0.1125)
+(-0.0030 0.0675 0.1125)
+(0.0000 0.0675 0.1125)
+(0.0030 0.0675 0.1125)
+(0.0060 0.0675 0.1125)
+(-0.0060 0.0705 0.1125)
+(-0.0030 0.0705 0.1125)
+(0.0000 0.0705 0.1125)
+(0.0030 0.0705 0.1125)
+(0.0060 0.0705 0.1125)
+(-0.0060 0.0735 0.1125)
+(-0.0030 0.0735 0.1125)
+(0.0000 0.0735 0.1125)
+(0.0030 0.0735 0.1125)
+(0.0060 0.0735 0.1125)
+(-0.0060 -0.0735 0.1155)
+(-0.0030 -0.0735 0.1155)
+(0.0000 -0.0735 0.1155)
+(0.0030 -0.0735 0.1155)
+(0.0060 -0.0735 0.1155)
+(-0.0060 -0.0705 0.1155)
+(-0.0030 -0.0705 0.1155)
+(0.0000 -0.0705 0.1155)
+(0.0030 -0.0705 0.1155)
+(0.0060 -0.0705 0.1155)
+(-0.0060 -0.0675 0.1155)
+(-0.0030 -0.0675 0.1155)
+(0.0000 -0.0675 0.1155)
+(0.0030 -0.0675 0.1155)
+(0.0060 -0.0675 0.1155)
+(-0.0060 -0.0645 0.1155)
+(-0.0030 -0.0645 0.1155)
+(0.0000 -0.0645 0.1155)
+(0.0030 -0.0645 0.1155)
+(0.0060 -0.0645 0.1155)
+(-0.0060 -0.0615 0.1155)
+(-0.0030 -0.0615 0.1155)
+(0.0000 -0.0615 0.1155)
+(0.0030 -0.0615 0.1155)
+(0.0060 -0.0615 0.1155)
+(-0.0060 -0.0585 0.1155)
+(-0.0030 -0.0585 0.1155)
+(0.0000 -0.0585 0.1155)
+(0.0030 -0.0585 0.1155)
+(0.0060 -0.0585 0.1155)
+(-0.0060 -0.0555 0.1155)
+(-0.0030 -0.0555 0.1155)
+(0.0000 -0.0555 0.1155)
+(0.0030 -0.0555 0.1155)
+(0.0060 -0.0555 0.1155)
+(-0.0060 -0.0525 0.1155)
+(-0.0030 -0.0525 0.1155)
+(0.0000 -0.0525 0.1155)
+(0.0030 -0.0525 0.1155)
+(0.0060 -0.0525 0.1155)
+(-0.0060 -0.0495 0.1155)
+(-0.0030 -0.0495 0.1155)
+(0.0000 -0.0495 0.1155)
+(0.0030 -0.0495 0.1155)
+(0.0060 -0.0495 0.1155)
+(-0.0060 -0.0465 0.1155)
+(-0.0030 -0.0465 0.1155)
+(0.0000 -0.0465 0.1155)
+(0.0030 -0.0465 0.1155)
+(0.0060 -0.0465 0.1155)
+(-0.0060 -0.0435 0.1155)
+(-0.0030 -0.0435 0.1155)
+(0.0000 -0.0435 0.1155)
+(0.0030 -0.0435 0.1155)
+(0.0060 -0.0435 0.1155)
+(-0.0060 -0.0405 0.1155)
+(-0.0030 -0.0405 0.1155)
+(0.0000 -0.0405 0.1155)
+(0.0030 -0.0405 0.1155)
+(0.0060 -0.0405 0.1155)
+(-0.0060 -0.0375 0.1155)
+(-0.0030 -0.0375 0.1155)
+(0.0000 -0.0375 0.1155)
+(0.0030 -0.0375 0.1155)
+(0.0060 -0.0375 0.1155)
+(-0.0060 -0.0345 0.1155)
+(-0.0030 -0.0345 0.1155)
+(0.0000 -0.0345 0.1155)
+(0.0030 -0.0345 0.1155)
+(0.0060 -0.0345 0.1155)
+(-0.0060 -0.0315 0.1155)
+(-0.0030 -0.0315 0.1155)
+(0.0000 -0.0315 0.1155)
+(0.0030 -0.0315 0.1155)
+(0.0060 -0.0315 0.1155)
+(-0.0060 -0.0285 0.1155)
+(-0.0030 -0.0285 0.1155)
+(0.0000 -0.0285 0.1155)
+(0.0030 -0.0285 0.1155)
+(0.0060 -0.0285 0.1155)
+(-0.0060 -0.0255 0.1155)
+(-0.0030 -0.0255 0.1155)
+(0.0000 -0.0255 0.1155)
+(0.0030 -0.0255 0.1155)
+(0.0060 -0.0255 0.1155)
+(-0.0060 -0.0225 0.1155)
+(-0.0030 -0.0225 0.1155)
+(0.0000 -0.0225 0.1155)
+(0.0030 -0.0225 0.1155)
+(0.0060 -0.0225 0.1155)
+(-0.0060 -0.0195 0.1155)
+(-0.0030 -0.0195 0.1155)
+(0.0000 -0.0195 0.1155)
+(0.0030 -0.0195 0.1155)
+(0.0060 -0.0195 0.1155)
+(-0.0060 -0.0165 0.1155)
+(-0.0030 -0.0165 0.1155)
+(0.0000 -0.0165 0.1155)
+(0.0030 -0.0165 0.1155)
+(0.0060 -0.0165 0.1155)
+(-0.0060 -0.0135 0.1155)
+(-0.0030 -0.0135 0.1155)
+(0.0000 -0.0135 0.1155)
+(0.0030 -0.0135 0.1155)
+(0.0060 -0.0135 0.1155)
+(-0.0060 -0.0105 0.1155)
+(-0.0030 -0.0105 0.1155)
+(0.0000 -0.0105 0.1155)
+(0.0030 -0.0105 0.1155)
+(0.0060 -0.0105 0.1155)
+(-0.0060 -0.0075 0.1155)
+(-0.0030 -0.0075 0.1155)
+(0.0000 -0.0075 0.1155)
+(0.0030 -0.0075 0.1155)
+(0.0060 -0.0075 0.1155)
+(-0.0060 -0.0045 0.1155)
+(-0.0030 -0.0045 0.1155)
+(0.0000 -0.0045 0.1155)
+(0.0030 -0.0045 0.1155)
+(0.0060 -0.0045 0.1155)
+(-0.0060 -0.0015 0.1155)
+(-0.0030 -0.0015 0.1155)
+(0.0000 -0.0015 0.1155)
+(0.0030 -0.0015 0.1155)
+(0.0060 -0.0015 0.1155)
+(-0.0060 0.0015 0.1155)
+(-0.0030 0.0015 0.1155)
+(0.0000 0.0015 0.1155)
+(0.0030 0.0015 0.1155)
+(0.0060 0.0015 0.1155)
+(-0.0060 0.0045 0.1155)
+(-0.0030 0.0045 0.1155)
+(0.0000 0.0045 0.1155)
+(0.0030 0.0045 0.1155)
+(0.0060 0.0045 0.1155)
+(-0.0060 0.0075 0.1155)
+(-0.0030 0.0075 0.1155)
+(0.0000 0.0075 0.1155)
+(0.0030 0.0075 0.1155)
+(0.0060 0.0075 0.1155)
+(-0.0060 0.0105 0.1155)
+(-0.0030 0.0105 0.1155)
+(0.0000 0.0105 0.1155)
+(0.0030 0.0105 0.1155)
+(0.0060 0.0105 0.1155)
+(-0.0060 0.0135 0.1155)
+(-0.0030 0.0135 0.1155)
+(0.0000 0.0135 0.1155)
+(0.0030 0.0135 0.1155)
+(0.0060 0.0135 0.1155)
+(-0.0060 0.0165 0.1155)
+(-0.0030 0.0165 0.1155)
+(0.0000 0.0165 0.1155)
+(0.0030 0.0165 0.1155)
+(0.0060 0.0165 0.1155)
+(-0.0060 0.0195 0.1155)
+(-0.0030 0.0195 0.1155)
+(0.0000 0.0195 0.1155)
+(0.0030 0.0195 0.1155)
+(0.0060 0.0195 0.1155)
+(-0.0060 0.0225 0.1155)
+(-0.0030 0.0225 0.1155)
+(0.0000 0.0225 0.1155)
+(0.0030 0.0225 0.1155)
+(0.0060 0.0225 0.1155)
+(-0.0060 0.0255 0.1155)
+(-0.0030 0.0255 0.1155)
+(0.0000 0.0255 0.1155)
+(0.0030 0.0255 0.1155)
+(0.0060 0.0255 0.1155)
+(-0.0060 0.0285 0.1155)
+(-0.0030 0.0285 0.1155)
+(0.0000 0.0285 0.1155)
+(0.0030 0.0285 0.1155)
+(0.0060 0.0285 0.1155)
+(-0.0060 0.0315 0.1155)
+(-0.0030 0.0315 0.1155)
+(0.0000 0.0315 0.1155)
+(0.0030 0.0315 0.1155)
+(0.0060 0.0315 0.1155)
+(-0.0060 0.0345 0.1155)
+(-0.0030 0.0345 0.1155)
+(0.0000 0.0345 0.1155)
+(0.0030 0.0345 0.1155)
+(0.0060 0.0345 0.1155)
+(-0.0060 0.0375 0.1155)
+(-0.0030 0.0375 0.1155)
+(0.0000 0.0375 0.1155)
+(0.0030 0.0375 0.1155)
+(0.0060 0.0375 0.1155)
+(-0.0060 0.0405 0.1155)
+(-0.0030 0.0405 0.1155)
+(0.0000 0.0405 0.1155)
+(0.0030 0.0405 0.1155)
+(0.0060 0.0405 0.1155)
+(-0.0060 0.0435 0.1155)
+(-0.0030 0.0435 0.1155)
+(0.0000 0.0435 0.1155)
+(0.0030 0.0435 0.1155)
+(0.0060 0.0435 0.1155)
+(-0.0060 0.0465 0.1155)
+(-0.0030 0.0465 0.1155)
+(0.0000 0.0465 0.1155)
+(0.0030 0.0465 0.1155)
+(0.0060 0.0465 0.1155)
+(-0.0060 0.0495 0.1155)
+(-0.0030 0.0495 0.1155)
+(0.0000 0.0495 0.1155)
+(0.0030 0.0495 0.1155)
+(0.0060 0.0495 0.1155)
+(-0.0060 0.0525 0.1155)
+(-0.0030 0.0525 0.1155)
+(0.0000 0.0525 0.1155)
+(0.0030 0.0525 0.1155)
+(0.0060 0.0525 0.1155)
+(-0.0060 0.0555 0.1155)
+(-0.0030 0.0555 0.1155)
+(0.0000 0.0555 0.1155)
+(0.0030 0.0555 0.1155)
+(0.0060 0.0555 0.1155)
+(-0.0060 0.0585 0.1155)
+(-0.0030 0.0585 0.1155)
+(0.0000 0.0585 0.1155)
+(0.0030 0.0585 0.1155)
+(0.0060 0.0585 0.1155)
+(-0.0060 0.0615 0.1155)
+(-0.0030 0.0615 0.1155)
+(0.0000 0.0615 0.1155)
+(0.0030 0.0615 0.1155)
+(0.0060 0.0615 0.1155)
+(-0.0060 0.0645 0.1155)
+(-0.0030 0.0645 0.1155)
+(0.0000 0.0645 0.1155)
+(0.0030 0.0645 0.1155)
+(0.0060 0.0645 0.1155)
+(-0.0060 0.0675 0.1155)
+(-0.0030 0.0675 0.1155)
+(0.0000 0.0675 0.1155)
+(0.0030 0.0675 0.1155)
+(0.0060 0.0675 0.1155)
+(-0.0060 0.0705 0.1155)
+(-0.0030 0.0705 0.1155)
+(0.0000 0.0705 0.1155)
+(0.0030 0.0705 0.1155)
+(0.0060 0.0705 0.1155)
+(-0.0060 0.0735 0.1155)
+(-0.0030 0.0735 0.1155)
+(0.0000 0.0735 0.1155)
+(0.0030 0.0735 0.1155)
+(0.0060 0.0735 0.1155)
+(-0.0060 -0.0735 0.1185)
+(-0.0030 -0.0735 0.1185)
+(0.0000 -0.0735 0.1185)
+(0.0030 -0.0735 0.1185)
+(0.0060 -0.0735 0.1185)
+(-0.0060 -0.0705 0.1185)
+(-0.0030 -0.0705 0.1185)
+(0.0000 -0.0705 0.1185)
+(0.0030 -0.0705 0.1185)
+(0.0060 -0.0705 0.1185)
+(-0.0060 -0.0675 0.1185)
+(-0.0030 -0.0675 0.1185)
+(0.0000 -0.0675 0.1185)
+(0.0030 -0.0675 0.1185)
+(0.0060 -0.0675 0.1185)
+(-0.0060 -0.0645 0.1185)
+(-0.0030 -0.0645 0.1185)
+(0.0000 -0.0645 0.1185)
+(0.0030 -0.0645 0.1185)
+(0.0060 -0.0645 0.1185)
+(-0.0060 -0.0615 0.1185)
+(-0.0030 -0.0615 0.1185)
+(0.0000 -0.0615 0.1185)
+(0.0030 -0.0615 0.1185)
+(0.0060 -0.0615 0.1185)
+(-0.0060 -0.0585 0.1185)
+(-0.0030 -0.0585 0.1185)
+(0.0000 -0.0585 0.1185)
+(0.0030 -0.0585 0.1185)
+(0.0060 -0.0585 0.1185)
+(-0.0060 -0.0555 0.1185)
+(-0.0030 -0.0555 0.1185)
+(0.0000 -0.0555 0.1185)
+(0.0030 -0.0555 0.1185)
+(0.0060 -0.0555 0.1185)
+(-0.0060 -0.0525 0.1185)
+(-0.0030 -0.0525 0.1185)
+(0.0000 -0.0525 0.1185)
+(0.0030 -0.0525 0.1185)
+(0.0060 -0.0525 0.1185)
+(-0.0060 -0.0495 0.1185)
+(-0.0030 -0.0495 0.1185)
+(0.0000 -0.0495 0.1185)
+(0.0030 -0.0495 0.1185)
+(0.0060 -0.0495 0.1185)
+(-0.0060 -0.0465 0.1185)
+(-0.0030 -0.0465 0.1185)
+(0.0000 -0.0465 0.1185)
+(0.0030 -0.0465 0.1185)
+(0.0060 -0.0465 0.1185)
+(-0.0060 -0.0435 0.1185)
+(-0.0030 -0.0435 0.1185)
+(0.0000 -0.0435 0.1185)
+(0.0030 -0.0435 0.1185)
+(0.0060 -0.0435 0.1185)
+(-0.0060 -0.0405 0.1185)
+(-0.0030 -0.0405 0.1185)
+(0.0000 -0.0405 0.1185)
+(0.0030 -0.0405 0.1185)
+(0.0060 -0.0405 0.1185)
+(-0.0060 -0.0375 0.1185)
+(-0.0030 -0.0375 0.1185)
+(0.0000 -0.0375 0.1185)
+(0.0030 -0.0375 0.1185)
+(0.0060 -0.0375 0.1185)
+(-0.0060 -0.0345 0.1185)
+(-0.0030 -0.0345 0.1185)
+(0.0000 -0.0345 0.1185)
+(0.0030 -0.0345 0.1185)
+(0.0060 -0.0345 0.1185)
+(-0.0060 -0.0315 0.1185)
+(-0.0030 -0.0315 0.1185)
+(0.0000 -0.0315 0.1185)
+(0.0030 -0.0315 0.1185)
+(0.0060 -0.0315 0.1185)
+(-0.0060 -0.0285 0.1185)
+(-0.0030 -0.0285 0.1185)
+(0.0000 -0.0285 0.1185)
+(0.0030 -0.0285 0.1185)
+(0.0060 -0.0285 0.1185)
+(-0.0060 -0.0255 0.1185)
+(-0.0030 -0.0255 0.1185)
+(0.0000 -0.0255 0.1185)
+(0.0030 -0.0255 0.1185)
+(0.0060 -0.0255 0.1185)
+(-0.0060 -0.0225 0.1185)
+(-0.0030 -0.0225 0.1185)
+(0.0000 -0.0225 0.1185)
+(0.0030 -0.0225 0.1185)
+(0.0060 -0.0225 0.1185)
+(-0.0060 -0.0195 0.1185)
+(-0.0030 -0.0195 0.1185)
+(0.0000 -0.0195 0.1185)
+(0.0030 -0.0195 0.1185)
+(0.0060 -0.0195 0.1185)
+(-0.0060 -0.0165 0.1185)
+(-0.0030 -0.0165 0.1185)
+(0.0000 -0.0165 0.1185)
+(0.0030 -0.0165 0.1185)
+(0.0060 -0.0165 0.1185)
+(-0.0060 -0.0135 0.1185)
+(-0.0030 -0.0135 0.1185)
+(0.0000 -0.0135 0.1185)
+(0.0030 -0.0135 0.1185)
+(0.0060 -0.0135 0.1185)
+(-0.0060 -0.0105 0.1185)
+(-0.0030 -0.0105 0.1185)
+(0.0000 -0.0105 0.1185)
+(0.0030 -0.0105 0.1185)
+(0.0060 -0.0105 0.1185)
+(-0.0060 -0.0075 0.1185)
+(-0.0030 -0.0075 0.1185)
+(0.0000 -0.0075 0.1185)
+(0.0030 -0.0075 0.1185)
+(0.0060 -0.0075 0.1185)
+(-0.0060 -0.0045 0.1185)
+(-0.0030 -0.0045 0.1185)
+(0.0000 -0.0045 0.1185)
+(0.0030 -0.0045 0.1185)
+(0.0060 -0.0045 0.1185)
+(-0.0060 -0.0015 0.1185)
+(-0.0030 -0.0015 0.1185)
+(0.0000 -0.0015 0.1185)
+(0.0030 -0.0015 0.1185)
+(0.0060 -0.0015 0.1185)
+(-0.0060 0.0015 0.1185)
+(-0.0030 0.0015 0.1185)
+(0.0000 0.0015 0.1185)
+(0.0030 0.0015 0.1185)
+(0.0060 0.0015 0.1185)
+(-0.0060 0.0045 0.1185)
+(-0.0030 0.0045 0.1185)
+(0.0000 0.0045 0.1185)
+(0.0030 0.0045 0.1185)
+(0.0060 0.0045 0.1185)
+(-0.0060 0.0075 0.1185)
+(-0.0030 0.0075 0.1185)
+(0.0000 0.0075 0.1185)
+(0.0030 0.0075 0.1185)
+(0.0060 0.0075 0.1185)
+(-0.0060 0.0105 0.1185)
+(-0.0030 0.0105 0.1185)
+(0.0000 0.0105 0.1185)
+(0.0030 0.0105 0.1185)
+(0.0060 0.0105 0.1185)
+(-0.0060 0.0135 0.1185)
+(-0.0030 0.0135 0.1185)
+(0.0000 0.0135 0.1185)
+(0.0030 0.0135 0.1185)
+(0.0060 0.0135 0.1185)
+(-0.0060 0.0165 0.1185)
+(-0.0030 0.0165 0.1185)
+(0.0000 0.0165 0.1185)
+(0.0030 0.0165 0.1185)
+(0.0060 0.0165 0.1185)
+(-0.0060 0.0195 0.1185)
+(-0.0030 0.0195 0.1185)
+(0.0000 0.0195 0.1185)
+(0.0030 0.0195 0.1185)
+(0.0060 0.0195 0.1185)
+(-0.0060 0.0225 0.1185)
+(-0.0030 0.0225 0.1185)
+(0.0000 0.0225 0.1185)
+(0.0030 0.0225 0.1185)
+(0.0060 0.0225 0.1185)
+(-0.0060 0.0255 0.1185)
+(-0.0030 0.0255 0.1185)
+(0.0000 0.0255 0.1185)
+(0.0030 0.0255 0.1185)
+(0.0060 0.0255 0.1185)
+(-0.0060 0.0285 0.1185)
+(-0.0030 0.0285 0.1185)
+(0.0000 0.0285 0.1185)
+(0.0030 0.0285 0.1185)
+(0.0060 0.0285 0.1185)
+(-0.0060 0.0315 0.1185)
+(-0.0030 0.0315 0.1185)
+(0.0000 0.0315 0.1185)
+(0.0030 0.0315 0.1185)
+(0.0060 0.0315 0.1185)
+(-0.0060 0.0345 0.1185)
+(-0.0030 0.0345 0.1185)
+(0.0000 0.0345 0.1185)
+(0.0030 0.0345 0.1185)
+(0.0060 0.0345 0.1185)
+(-0.0060 0.0375 0.1185)
+(-0.0030 0.0375 0.1185)
+(0.0000 0.0375 0.1185)
+(0.0030 0.0375 0.1185)
+(0.0060 0.0375 0.1185)
+(-0.0060 0.0405 0.1185)
+(-0.0030 0.0405 0.1185)
+(0.0000 0.0405 0.1185)
+(0.0030 0.0405 0.1185)
+(0.0060 0.0405 0.1185)
+(-0.0060 0.0435 0.1185)
+(-0.0030 0.0435 0.1185)
+(0.0000 0.0435 0.1185)
+(0.0030 0.0435 0.1185)
+(0.0060 0.0435 0.1185)
+(-0.0060 0.0465 0.1185)
+(-0.0030 0.0465 0.1185)
+(0.0000 0.0465 0.1185)
+(0.0030 0.0465 0.1185)
+(0.0060 0.0465 0.1185)
+(-0.0060 0.0495 0.1185)
+(-0.0030 0.0495 0.1185)
+(0.0000 0.0495 0.1185)
+(0.0030 0.0495 0.1185)
+(0.0060 0.0495 0.1185)
+(-0.0060 0.0525 0.1185)
+(-0.0030 0.0525 0.1185)
+(0.0000 0.0525 0.1185)
+(0.0030 0.0525 0.1185)
+(0.0060 0.0525 0.1185)
+(-0.0060 0.0555 0.1185)
+(-0.0030 0.0555 0.1185)
+(0.0000 0.0555 0.1185)
+(0.0030 0.0555 0.1185)
+(0.0060 0.0555 0.1185)
+(-0.0060 0.0585 0.1185)
+(-0.0030 0.0585 0.1185)
+(0.0000 0.0585 0.1185)
+(0.0030 0.0585 0.1185)
+(0.0060 0.0585 0.1185)
+(-0.0060 0.0615 0.1185)
+(-0.0030 0.0615 0.1185)
+(0.0000 0.0615 0.1185)
+(0.0030 0.0615 0.1185)
+(0.0060 0.0615 0.1185)
+(-0.0060 0.0645 0.1185)
+(-0.0030 0.0645 0.1185)
+(0.0000 0.0645 0.1185)
+(0.0030 0.0645 0.1185)
+(0.0060 0.0645 0.1185)
+(-0.0060 0.0675 0.1185)
+(-0.0030 0.0675 0.1185)
+(0.0000 0.0675 0.1185)
+(0.0030 0.0675 0.1185)
+(0.0060 0.0675 0.1185)
+(-0.0060 0.0705 0.1185)
+(-0.0030 0.0705 0.1185)
+(0.0000 0.0705 0.1185)
+(0.0030 0.0705 0.1185)
+(0.0060 0.0705 0.1185)
+(-0.0060 0.0735 0.1185)
+(-0.0030 0.0735 0.1185)
+(0.0000 0.0735 0.1185)
+(0.0030 0.0735 0.1185)
+(0.0060 0.0735 0.1185)
+(-0.0060 -0.0735 0.1215)
+(-0.0030 -0.0735 0.1215)
+(0.0000 -0.0735 0.1215)
+(0.0030 -0.0735 0.1215)
+(0.0060 -0.0735 0.1215)
+(-0.0060 -0.0705 0.1215)
+(-0.0030 -0.0705 0.1215)
+(0.0000 -0.0705 0.1215)
+(0.0030 -0.0705 0.1215)
+(0.0060 -0.0705 0.1215)
+(-0.0060 -0.0675 0.1215)
+(-0.0030 -0.0675 0.1215)
+(0.0000 -0.0675 0.1215)
+(0.0030 -0.0675 0.1215)
+(0.0060 -0.0675 0.1215)
+(-0.0060 -0.0645 0.1215)
+(-0.0030 -0.0645 0.1215)
+(0.0000 -0.0645 0.1215)
+(0.0030 -0.0645 0.1215)
+(0.0060 -0.0645 0.1215)
+(-0.0060 -0.0615 0.1215)
+(-0.0030 -0.0615 0.1215)
+(0.0000 -0.0615 0.1215)
+(0.0030 -0.0615 0.1215)
+(0.0060 -0.0615 0.1215)
+(-0.0060 -0.0585 0.1215)
+(-0.0030 -0.0585 0.1215)
+(0.0000 -0.0585 0.1215)
+(0.0030 -0.0585 0.1215)
+(0.0060 -0.0585 0.1215)
+(-0.0060 -0.0555 0.1215)
+(-0.0030 -0.0555 0.1215)
+(0.0000 -0.0555 0.1215)
+(0.0030 -0.0555 0.1215)
+(0.0060 -0.0555 0.1215)
+(-0.0060 -0.0525 0.1215)
+(-0.0030 -0.0525 0.1215)
+(0.0000 -0.0525 0.1215)
+(0.0030 -0.0525 0.1215)
+(0.0060 -0.0525 0.1215)
+(-0.0060 -0.0495 0.1215)
+(-0.0030 -0.0495 0.1215)
+(0.0000 -0.0495 0.1215)
+(0.0030 -0.0495 0.1215)
+(0.0060 -0.0495 0.1215)
+(-0.0060 -0.0465 0.1215)
+(-0.0030 -0.0465 0.1215)
+(0.0000 -0.0465 0.1215)
+(0.0030 -0.0465 0.1215)
+(0.0060 -0.0465 0.1215)
+(-0.0060 -0.0435 0.1215)
+(-0.0030 -0.0435 0.1215)
+(0.0000 -0.0435 0.1215)
+(0.0030 -0.0435 0.1215)
+(0.0060 -0.0435 0.1215)
+(-0.0060 -0.0405 0.1215)
+(-0.0030 -0.0405 0.1215)
+(0.0000 -0.0405 0.1215)
+(0.0030 -0.0405 0.1215)
+(0.0060 -0.0405 0.1215)
+(-0.0060 -0.0375 0.1215)
+(-0.0030 -0.0375 0.1215)
+(0.0000 -0.0375 0.1215)
+(0.0030 -0.0375 0.1215)
+(0.0060 -0.0375 0.1215)
+(-0.0060 -0.0345 0.1215)
+(-0.0030 -0.0345 0.1215)
+(0.0000 -0.0345 0.1215)
+(0.0030 -0.0345 0.1215)
+(0.0060 -0.0345 0.1215)
+(-0.0060 -0.0315 0.1215)
+(-0.0030 -0.0315 0.1215)
+(0.0000 -0.0315 0.1215)
+(0.0030 -0.0315 0.1215)
+(0.0060 -0.0315 0.1215)
+(-0.0060 -0.0285 0.1215)
+(-0.0030 -0.0285 0.1215)
+(0.0000 -0.0285 0.1215)
+(0.0030 -0.0285 0.1215)
+(0.0060 -0.0285 0.1215)
+(-0.0060 -0.0255 0.1215)
+(-0.0030 -0.0255 0.1215)
+(0.0000 -0.0255 0.1215)
+(0.0030 -0.0255 0.1215)
+(0.0060 -0.0255 0.1215)
+(-0.0060 -0.0225 0.1215)
+(-0.0030 -0.0225 0.1215)
+(0.0000 -0.0225 0.1215)
+(0.0030 -0.0225 0.1215)
+(0.0060 -0.0225 0.1215)
+(-0.0060 -0.0195 0.1215)
+(-0.0030 -0.0195 0.1215)
+(0.0000 -0.0195 0.1215)
+(0.0030 -0.0195 0.1215)
+(0.0060 -0.0195 0.1215)
+(-0.0060 -0.0165 0.1215)
+(-0.0030 -0.0165 0.1215)
+(0.0000 -0.0165 0.1215)
+(0.0030 -0.0165 0.1215)
+(0.0060 -0.0165 0.1215)
+(-0.0060 -0.0135 0.1215)
+(-0.0030 -0.0135 0.1215)
+(0.0000 -0.0135 0.1215)
+(0.0030 -0.0135 0.1215)
+(0.0060 -0.0135 0.1215)
+(-0.0060 -0.0105 0.1215)
+(-0.0030 -0.0105 0.1215)
+(0.0000 -0.0105 0.1215)
+(0.0030 -0.0105 0.1215)
+(0.0060 -0.0105 0.1215)
+(-0.0060 -0.0075 0.1215)
+(-0.0030 -0.0075 0.1215)
+(0.0000 -0.0075 0.1215)
+(0.0030 -0.0075 0.1215)
+(0.0060 -0.0075 0.1215)
+(-0.0060 -0.0045 0.1215)
+(-0.0030 -0.0045 0.1215)
+(0.0000 -0.0045 0.1215)
+(0.0030 -0.0045 0.1215)
+(0.0060 -0.0045 0.1215)
+(-0.0060 -0.0015 0.1215)
+(-0.0030 -0.0015 0.1215)
+(0.0000 -0.0015 0.1215)
+(0.0030 -0.0015 0.1215)
+(0.0060 -0.0015 0.1215)
+(-0.0060 0.0015 0.1215)
+(-0.0030 0.0015 0.1215)
+(0.0000 0.0015 0.1215)
+(0.0030 0.0015 0.1215)
+(0.0060 0.0015 0.1215)
+(-0.0060 0.0045 0.1215)
+(-0.0030 0.0045 0.1215)
+(0.0000 0.0045 0.1215)
+(0.0030 0.0045 0.1215)
+(0.0060 0.0045 0.1215)
+(-0.0060 0.0075 0.1215)
+(-0.0030 0.0075 0.1215)
+(0.0000 0.0075 0.1215)
+(0.0030 0.0075 0.1215)
+(0.0060 0.0075 0.1215)
+(-0.0060 0.0105 0.1215)
+(-0.0030 0.0105 0.1215)
+(0.0000 0.0105 0.1215)
+(0.0030 0.0105 0.1215)
+(0.0060 0.0105 0.1215)
+(-0.0060 0.0135 0.1215)
+(-0.0030 0.0135 0.1215)
+(0.0000 0.0135 0.1215)
+(0.0030 0.0135 0.1215)
+(0.0060 0.0135 0.1215)
+(-0.0060 0.0165 0.1215)
+(-0.0030 0.0165 0.1215)
+(0.0000 0.0165 0.1215)
+(0.0030 0.0165 0.1215)
+(0.0060 0.0165 0.1215)
+(-0.0060 0.0195 0.1215)
+(-0.0030 0.0195 0.1215)
+(0.0000 0.0195 0.1215)
+(0.0030 0.0195 0.1215)
+(0.0060 0.0195 0.1215)
+(-0.0060 0.0225 0.1215)
+(-0.0030 0.0225 0.1215)
+(0.0000 0.0225 0.1215)
+(0.0030 0.0225 0.1215)
+(0.0060 0.0225 0.1215)
+(-0.0060 0.0255 0.1215)
+(-0.0030 0.0255 0.1215)
+(0.0000 0.0255 0.1215)
+(0.0030 0.0255 0.1215)
+(0.0060 0.0255 0.1215)
+(-0.0060 0.0285 0.1215)
+(-0.0030 0.0285 0.1215)
+(0.0000 0.0285 0.1215)
+(0.0030 0.0285 0.1215)
+(0.0060 0.0285 0.1215)
+(-0.0060 0.0315 0.1215)
+(-0.0030 0.0315 0.1215)
+(0.0000 0.0315 0.1215)
+(0.0030 0.0315 0.1215)
+(0.0060 0.0315 0.1215)
+(-0.0060 0.0345 0.1215)
+(-0.0030 0.0345 0.1215)
+(0.0000 0.0345 0.1215)
+(0.0030 0.0345 0.1215)
+(0.0060 0.0345 0.1215)
+(-0.0060 0.0375 0.1215)
+(-0.0030 0.0375 0.1215)
+(0.0000 0.0375 0.1215)
+(0.0030 0.0375 0.1215)
+(0.0060 0.0375 0.1215)
+(-0.0060 0.0405 0.1215)
+(-0.0030 0.0405 0.1215)
+(0.0000 0.0405 0.1215)
+(0.0030 0.0405 0.1215)
+(0.0060 0.0405 0.1215)
+(-0.0060 0.0435 0.1215)
+(-0.0030 0.0435 0.1215)
+(0.0000 0.0435 0.1215)
+(0.0030 0.0435 0.1215)
+(0.0060 0.0435 0.1215)
+(-0.0060 0.0465 0.1215)
+(-0.0030 0.0465 0.1215)
+(0.0000 0.0465 0.1215)
+(0.0030 0.0465 0.1215)
+(0.0060 0.0465 0.1215)
+(-0.0060 0.0495 0.1215)
+(-0.0030 0.0495 0.1215)
+(0.0000 0.0495 0.1215)
+(0.0030 0.0495 0.1215)
+(0.0060 0.0495 0.1215)
+(-0.0060 0.0525 0.1215)
+(-0.0030 0.0525 0.1215)
+(0.0000 0.0525 0.1215)
+(0.0030 0.0525 0.1215)
+(0.0060 0.0525 0.1215)
+(-0.0060 0.0555 0.1215)
+(-0.0030 0.0555 0.1215)
+(0.0000 0.0555 0.1215)
+(0.0030 0.0555 0.1215)
+(0.0060 0.0555 0.1215)
+(-0.0060 0.0585 0.1215)
+(-0.0030 0.0585 0.1215)
+(0.0000 0.0585 0.1215)
+(0.0030 0.0585 0.1215)
+(0.0060 0.0585 0.1215)
+(-0.0060 0.0615 0.1215)
+(-0.0030 0.0615 0.1215)
+(0.0000 0.0615 0.1215)
+(0.0030 0.0615 0.1215)
+(0.0060 0.0615 0.1215)
+(-0.0060 0.0645 0.1215)
+(-0.0030 0.0645 0.1215)
+(0.0000 0.0645 0.1215)
+(0.0030 0.0645 0.1215)
+(0.0060 0.0645 0.1215)
+(-0.0060 0.0675 0.1215)
+(-0.0030 0.0675 0.1215)
+(0.0000 0.0675 0.1215)
+(0.0030 0.0675 0.1215)
+(0.0060 0.0675 0.1215)
+(-0.0060 0.0705 0.1215)
+(-0.0030 0.0705 0.1215)
+(0.0000 0.0705 0.1215)
+(0.0030 0.0705 0.1215)
+(0.0060 0.0705 0.1215)
+(-0.0060 0.0735 0.1215)
+(-0.0030 0.0735 0.1215)
+(0.0000 0.0735 0.1215)
+(0.0030 0.0735 0.1215)
+(0.0060 0.0735 0.1215)
+(-0.0060 -0.0735 0.1245)
+(-0.0030 -0.0735 0.1245)
+(0.0000 -0.0735 0.1245)
+(0.0030 -0.0735 0.1245)
+(0.0060 -0.0735 0.1245)
+(-0.0060 -0.0705 0.1245)
+(-0.0030 -0.0705 0.1245)
+(0.0000 -0.0705 0.1245)
+(0.0030 -0.0705 0.1245)
+(0.0060 -0.0705 0.1245)
+(-0.0060 -0.0675 0.1245)
+(-0.0030 -0.0675 0.1245)
+(0.0000 -0.0675 0.1245)
+(0.0030 -0.0675 0.1245)
+(0.0060 -0.0675 0.1245)
+(-0.0060 -0.0645 0.1245)
+(-0.0030 -0.0645 0.1245)
+(0.0000 -0.0645 0.1245)
+(0.0030 -0.0645 0.1245)
+(0.0060 -0.0645 0.1245)
+(-0.0060 -0.0615 0.1245)
+(-0.0030 -0.0615 0.1245)
+(0.0000 -0.0615 0.1245)
+(0.0030 -0.0615 0.1245)
+(0.0060 -0.0615 0.1245)
+(-0.0060 -0.0585 0.1245)
+(-0.0030 -0.0585 0.1245)
+(0.0000 -0.0585 0.1245)
+(0.0030 -0.0585 0.1245)
+(0.0060 -0.0585 0.1245)
+(-0.0060 -0.0555 0.1245)
+(-0.0030 -0.0555 0.1245)
+(0.0000 -0.0555 0.1245)
+(0.0030 -0.0555 0.1245)
+(0.0060 -0.0555 0.1245)
+(-0.0060 -0.0525 0.1245)
+(-0.0030 -0.0525 0.1245)
+(0.0000 -0.0525 0.1245)
+(0.0030 -0.0525 0.1245)
+(0.0060 -0.0525 0.1245)
+(-0.0060 -0.0495 0.1245)
+(-0.0030 -0.0495 0.1245)
+(0.0000 -0.0495 0.1245)
+(0.0030 -0.0495 0.1245)
+(0.0060 -0.0495 0.1245)
+(-0.0060 -0.0465 0.1245)
+(-0.0030 -0.0465 0.1245)
+(0.0000 -0.0465 0.1245)
+(0.0030 -0.0465 0.1245)
+(0.0060 -0.0465 0.1245)
+(-0.0060 -0.0435 0.1245)
+(-0.0030 -0.0435 0.1245)
+(0.0000 -0.0435 0.1245)
+(0.0030 -0.0435 0.1245)
+(0.0060 -0.0435 0.1245)
+(-0.0060 -0.0405 0.1245)
+(-0.0030 -0.0405 0.1245)
+(0.0000 -0.0405 0.1245)
+(0.0030 -0.0405 0.1245)
+(0.0060 -0.0405 0.1245)
+(-0.0060 -0.0375 0.1245)
+(-0.0030 -0.0375 0.1245)
+(0.0000 -0.0375 0.1245)
+(0.0030 -0.0375 0.1245)
+(0.0060 -0.0375 0.1245)
+(-0.0060 -0.0345 0.1245)
+(-0.0030 -0.0345 0.1245)
+(0.0000 -0.0345 0.1245)
+(0.0030 -0.0345 0.1245)
+(0.0060 -0.0345 0.1245)
+(-0.0060 -0.0315 0.1245)
+(-0.0030 -0.0315 0.1245)
+(0.0000 -0.0315 0.1245)
+(0.0030 -0.0315 0.1245)
+(0.0060 -0.0315 0.1245)
+(-0.0060 -0.0285 0.1245)
+(-0.0030 -0.0285 0.1245)
+(0.0000 -0.0285 0.1245)
+(0.0030 -0.0285 0.1245)
+(0.0060 -0.0285 0.1245)
+(-0.0060 -0.0255 0.1245)
+(-0.0030 -0.0255 0.1245)
+(0.0000 -0.0255 0.1245)
+(0.0030 -0.0255 0.1245)
+(0.0060 -0.0255 0.1245)
+(-0.0060 -0.0225 0.1245)
+(-0.0030 -0.0225 0.1245)
+(0.0000 -0.0225 0.1245)
+(0.0030 -0.0225 0.1245)
+(0.0060 -0.0225 0.1245)
+(-0.0060 -0.0195 0.1245)
+(-0.0030 -0.0195 0.1245)
+(0.0000 -0.0195 0.1245)
+(0.0030 -0.0195 0.1245)
+(0.0060 -0.0195 0.1245)
+(-0.0060 -0.0165 0.1245)
+(-0.0030 -0.0165 0.1245)
+(0.0000 -0.0165 0.1245)
+(0.0030 -0.0165 0.1245)
+(0.0060 -0.0165 0.1245)
+(-0.0060 -0.0135 0.1245)
+(-0.0030 -0.0135 0.1245)
+(0.0000 -0.0135 0.1245)
+(0.0030 -0.0135 0.1245)
+(0.0060 -0.0135 0.1245)
+(-0.0060 -0.0105 0.1245)
+(-0.0030 -0.0105 0.1245)
+(0.0000 -0.0105 0.1245)
+(0.0030 -0.0105 0.1245)
+(0.0060 -0.0105 0.1245)
+(-0.0060 -0.0075 0.1245)
+(-0.0030 -0.0075 0.1245)
+(0.0000 -0.0075 0.1245)
+(0.0030 -0.0075 0.1245)
+(0.0060 -0.0075 0.1245)
+(-0.0060 -0.0045 0.1245)
+(-0.0030 -0.0045 0.1245)
+(0.0000 -0.0045 0.1245)
+(0.0030 -0.0045 0.1245)
+(0.0060 -0.0045 0.1245)
+(-0.0060 -0.0015 0.1245)
+(-0.0030 -0.0015 0.1245)
+(0.0000 -0.0015 0.1245)
+(0.0030 -0.0015 0.1245)
+(0.0060 -0.0015 0.1245)
+(-0.0060 0.0015 0.1245)
+(-0.0030 0.0015 0.1245)
+(0.0000 0.0015 0.1245)
+(0.0030 0.0015 0.1245)
+(0.0060 0.0015 0.1245)
+(-0.0060 0.0045 0.1245)
+(-0.0030 0.0045 0.1245)
+(0.0000 0.0045 0.1245)
+(0.0030 0.0045 0.1245)
+(0.0060 0.0045 0.1245)
+(-0.0060 0.0075 0.1245)
+(-0.0030 0.0075 0.1245)
+(0.0000 0.0075 0.1245)
+(0.0030 0.0075 0.1245)
+(0.0060 0.0075 0.1245)
+(-0.0060 0.0105 0.1245)
+(-0.0030 0.0105 0.1245)
+(0.0000 0.0105 0.1245)
+(0.0030 0.0105 0.1245)
+(0.0060 0.0105 0.1245)
+(-0.0060 0.0135 0.1245)
+(-0.0030 0.0135 0.1245)
+(0.0000 0.0135 0.1245)
+(0.0030 0.0135 0.1245)
+(0.0060 0.0135 0.1245)
+(-0.0060 0.0165 0.1245)
+(-0.0030 0.0165 0.1245)
+(0.0000 0.0165 0.1245)
+(0.0030 0.0165 0.1245)
+(0.0060 0.0165 0.1245)
+(-0.0060 0.0195 0.1245)
+(-0.0030 0.0195 0.1245)
+(0.0000 0.0195 0.1245)
+(0.0030 0.0195 0.1245)
+(0.0060 0.0195 0.1245)
+(-0.0060 0.0225 0.1245)
+(-0.0030 0.0225 0.1245)
+(0.0000 0.0225 0.1245)
+(0.0030 0.0225 0.1245)
+(0.0060 0.0225 0.1245)
+(-0.0060 0.0255 0.1245)
+(-0.0030 0.0255 0.1245)
+(0.0000 0.0255 0.1245)
+(0.0030 0.0255 0.1245)
+(0.0060 0.0255 0.1245)
+(-0.0060 0.0285 0.1245)
+(-0.0030 0.0285 0.1245)
+(0.0000 0.0285 0.1245)
+(0.0030 0.0285 0.1245)
+(0.0060 0.0285 0.1245)
+(-0.0060 0.0315 0.1245)
+(-0.0030 0.0315 0.1245)
+(0.0000 0.0315 0.1245)
+(0.0030 0.0315 0.1245)
+(0.0060 0.0315 0.1245)
+(-0.0060 0.0345 0.1245)
+(-0.0030 0.0345 0.1245)
+(0.0000 0.0345 0.1245)
+(0.0030 0.0345 0.1245)
+(0.0060 0.0345 0.1245)
+(-0.0060 0.0375 0.1245)
+(-0.0030 0.0375 0.1245)
+(0.0000 0.0375 0.1245)
+(0.0030 0.0375 0.1245)
+(0.0060 0.0375 0.1245)
+(-0.0060 0.0405 0.1245)
+(-0.0030 0.0405 0.1245)
+(0.0000 0.0405 0.1245)
+(0.0030 0.0405 0.1245)
+(0.0060 0.0405 0.1245)
+(-0.0060 0.0435 0.1245)
+(-0.0030 0.0435 0.1245)
+(0.0000 0.0435 0.1245)
+(0.0030 0.0435 0.1245)
+(0.0060 0.0435 0.1245)
+(-0.0060 0.0465 0.1245)
+(-0.0030 0.0465 0.1245)
+(0.0000 0.0465 0.1245)
+(0.0030 0.0465 0.1245)
+(0.0060 0.0465 0.1245)
+(-0.0060 0.0495 0.1245)
+(-0.0030 0.0495 0.1245)
+(0.0000 0.0495 0.1245)
+(0.0030 0.0495 0.1245)
+(0.0060 0.0495 0.1245)
+(-0.0060 0.0525 0.1245)
+(-0.0030 0.0525 0.1245)
+(0.0000 0.0525 0.1245)
+(0.0030 0.0525 0.1245)
+(0.0060 0.0525 0.1245)
+(-0.0060 0.0555 0.1245)
+(-0.0030 0.0555 0.1245)
+(0.0000 0.0555 0.1245)
+(0.0030 0.0555 0.1245)
+(0.0060 0.0555 0.1245)
+(-0.0060 0.0585 0.1245)
+(-0.0030 0.0585 0.1245)
+(0.0000 0.0585 0.1245)
+(0.0030 0.0585 0.1245)
+(0.0060 0.0585 0.1245)
+(-0.0060 0.0615 0.1245)
+(-0.0030 0.0615 0.1245)
+(0.0000 0.0615 0.1245)
+(0.0030 0.0615 0.1245)
+(0.0060 0.0615 0.1245)
+(-0.0060 0.0645 0.1245)
+(-0.0030 0.0645 0.1245)
+(0.0000 0.0645 0.1245)
+(0.0030 0.0645 0.1245)
+(0.0060 0.0645 0.1245)
+(-0.0060 0.0675 0.1245)
+(-0.0030 0.0675 0.1245)
+(0.0000 0.0675 0.1245)
+(0.0030 0.0675 0.1245)
+(0.0060 0.0675 0.1245)
+(-0.0060 0.0705 0.1245)
+(-0.0030 0.0705 0.1245)
+(0.0000 0.0705 0.1245)
+(0.0030 0.0705 0.1245)
+(0.0060 0.0705 0.1245)
+(-0.0060 0.0735 0.1245)
+(-0.0030 0.0735 0.1245)
+(0.0000 0.0735 0.1245)
+(0.0030 0.0735 0.1245)
+(0.0060 0.0735 0.1245)
+(-0.0060 -0.0735 0.1275)
+(-0.0030 -0.0735 0.1275)
+(0.0000 -0.0735 0.1275)
+(0.0030 -0.0735 0.1275)
+(0.0060 -0.0735 0.1275)
+(-0.0060 -0.0705 0.1275)
+(-0.0030 -0.0705 0.1275)
+(0.0000 -0.0705 0.1275)
+(0.0030 -0.0705 0.1275)
+(0.0060 -0.0705 0.1275)
+(-0.0060 -0.0675 0.1275)
+(-0.0030 -0.0675 0.1275)
+(0.0000 -0.0675 0.1275)
+(0.0030 -0.0675 0.1275)
+(0.0060 -0.0675 0.1275)
+(-0.0060 -0.0645 0.1275)
+(-0.0030 -0.0645 0.1275)
+(0.0000 -0.0645 0.1275)
+(0.0030 -0.0645 0.1275)
+(0.0060 -0.0645 0.1275)
+(-0.0060 -0.0615 0.1275)
+(-0.0030 -0.0615 0.1275)
+(0.0000 -0.0615 0.1275)
+(0.0030 -0.0615 0.1275)
+(0.0060 -0.0615 0.1275)
+(-0.0060 -0.0585 0.1275)
+(-0.0030 -0.0585 0.1275)
+(0.0000 -0.0585 0.1275)
+(0.0030 -0.0585 0.1275)
+(0.0060 -0.0585 0.1275)
+(-0.0060 -0.0555 0.1275)
+(-0.0030 -0.0555 0.1275)
+(0.0000 -0.0555 0.1275)
+(0.0030 -0.0555 0.1275)
+(0.0060 -0.0555 0.1275)
+(-0.0060 -0.0525 0.1275)
+(-0.0030 -0.0525 0.1275)
+(0.0000 -0.0525 0.1275)
+(0.0030 -0.0525 0.1275)
+(0.0060 -0.0525 0.1275)
+(-0.0060 -0.0495 0.1275)
+(-0.0030 -0.0495 0.1275)
+(0.0000 -0.0495 0.1275)
+(0.0030 -0.0495 0.1275)
+(0.0060 -0.0495 0.1275)
+(-0.0060 -0.0465 0.1275)
+(-0.0030 -0.0465 0.1275)
+(0.0000 -0.0465 0.1275)
+(0.0030 -0.0465 0.1275)
+(0.0060 -0.0465 0.1275)
+(-0.0060 -0.0435 0.1275)
+(-0.0030 -0.0435 0.1275)
+(0.0000 -0.0435 0.1275)
+(0.0030 -0.0435 0.1275)
+(0.0060 -0.0435 0.1275)
+(-0.0060 -0.0405 0.1275)
+(-0.0030 -0.0405 0.1275)
+(0.0000 -0.0405 0.1275)
+(0.0030 -0.0405 0.1275)
+(0.0060 -0.0405 0.1275)
+(-0.0060 -0.0375 0.1275)
+(-0.0030 -0.0375 0.1275)
+(0.0000 -0.0375 0.1275)
+(0.0030 -0.0375 0.1275)
+(0.0060 -0.0375 0.1275)
+(-0.0060 -0.0345 0.1275)
+(-0.0030 -0.0345 0.1275)
+(0.0000 -0.0345 0.1275)
+(0.0030 -0.0345 0.1275)
+(0.0060 -0.0345 0.1275)
+(-0.0060 -0.0315 0.1275)
+(-0.0030 -0.0315 0.1275)
+(0.0000 -0.0315 0.1275)
+(0.0030 -0.0315 0.1275)
+(0.0060 -0.0315 0.1275)
+(-0.0060 -0.0285 0.1275)
+(-0.0030 -0.0285 0.1275)
+(0.0000 -0.0285 0.1275)
+(0.0030 -0.0285 0.1275)
+(0.0060 -0.0285 0.1275)
+(-0.0060 -0.0255 0.1275)
+(-0.0030 -0.0255 0.1275)
+(0.0000 -0.0255 0.1275)
+(0.0030 -0.0255 0.1275)
+(0.0060 -0.0255 0.1275)
+(-0.0060 -0.0225 0.1275)
+(-0.0030 -0.0225 0.1275)
+(0.0000 -0.0225 0.1275)
+(0.0030 -0.0225 0.1275)
+(0.0060 -0.0225 0.1275)
+(-0.0060 -0.0195 0.1275)
+(-0.0030 -0.0195 0.1275)
+(0.0000 -0.0195 0.1275)
+(0.0030 -0.0195 0.1275)
+(0.0060 -0.0195 0.1275)
+(-0.0060 -0.0165 0.1275)
+(-0.0030 -0.0165 0.1275)
+(0.0000 -0.0165 0.1275)
+(0.0030 -0.0165 0.1275)
+(0.0060 -0.0165 0.1275)
+(-0.0060 -0.0135 0.1275)
+(-0.0030 -0.0135 0.1275)
+(0.0000 -0.0135 0.1275)
+(0.0030 -0.0135 0.1275)
+(0.0060 -0.0135 0.1275)
+(-0.0060 -0.0105 0.1275)
+(-0.0030 -0.0105 0.1275)
+(0.0000 -0.0105 0.1275)
+(0.0030 -0.0105 0.1275)
+(0.0060 -0.0105 0.1275)
+(-0.0060 -0.0075 0.1275)
+(-0.0030 -0.0075 0.1275)
+(0.0000 -0.0075 0.1275)
+(0.0030 -0.0075 0.1275)
+(0.0060 -0.0075 0.1275)
+(-0.0060 -0.0045 0.1275)
+(-0.0030 -0.0045 0.1275)
+(0.0000 -0.0045 0.1275)
+(0.0030 -0.0045 0.1275)
+(0.0060 -0.0045 0.1275)
+(-0.0060 -0.0015 0.1275)
+(-0.0030 -0.0015 0.1275)
+(0.0000 -0.0015 0.1275)
+(0.0030 -0.0015 0.1275)
+(0.0060 -0.0015 0.1275)
+(-0.0060 0.0015 0.1275)
+(-0.0030 0.0015 0.1275)
+(0.0000 0.0015 0.1275)
+(0.0030 0.0015 0.1275)
+(0.0060 0.0015 0.1275)
+(-0.0060 0.0045 0.1275)
+(-0.0030 0.0045 0.1275)
+(0.0000 0.0045 0.1275)
+(0.0030 0.0045 0.1275)
+(0.0060 0.0045 0.1275)
+(-0.0060 0.0075 0.1275)
+(-0.0030 0.0075 0.1275)
+(0.0000 0.0075 0.1275)
+(0.0030 0.0075 0.1275)
+(0.0060 0.0075 0.1275)
+(-0.0060 0.0105 0.1275)
+(-0.0030 0.0105 0.1275)
+(0.0000 0.0105 0.1275)
+(0.0030 0.0105 0.1275)
+(0.0060 0.0105 0.1275)
+(-0.0060 0.0135 0.1275)
+(-0.0030 0.0135 0.1275)
+(0.0000 0.0135 0.1275)
+(0.0030 0.0135 0.1275)
+(0.0060 0.0135 0.1275)
+(-0.0060 0.0165 0.1275)
+(-0.0030 0.0165 0.1275)
+(0.0000 0.0165 0.1275)
+(0.0030 0.0165 0.1275)
+(0.0060 0.0165 0.1275)
+(-0.0060 0.0195 0.1275)
+(-0.0030 0.0195 0.1275)
+(0.0000 0.0195 0.1275)
+(0.0030 0.0195 0.1275)
+(0.0060 0.0195 0.1275)
+(-0.0060 0.0225 0.1275)
+(-0.0030 0.0225 0.1275)
+(0.0000 0.0225 0.1275)
+(0.0030 0.0225 0.1275)
+(0.0060 0.0225 0.1275)
+(-0.0060 0.0255 0.1275)
+(-0.0030 0.0255 0.1275)
+(0.0000 0.0255 0.1275)
+(0.0030 0.0255 0.1275)
+(0.0060 0.0255 0.1275)
+(-0.0060 0.0285 0.1275)
+(-0.0030 0.0285 0.1275)
+(0.0000 0.0285 0.1275)
+(0.0030 0.0285 0.1275)
+(0.0060 0.0285 0.1275)
+(-0.0060 0.0315 0.1275)
+(-0.0030 0.0315 0.1275)
+(0.0000 0.0315 0.1275)
+(0.0030 0.0315 0.1275)
+(0.0060 0.0315 0.1275)
+(-0.0060 0.0345 0.1275)
+(-0.0030 0.0345 0.1275)
+(0.0000 0.0345 0.1275)
+(0.0030 0.0345 0.1275)
+(0.0060 0.0345 0.1275)
+(-0.0060 0.0375 0.1275)
+(-0.0030 0.0375 0.1275)
+(0.0000 0.0375 0.1275)
+(0.0030 0.0375 0.1275)
+(0.0060 0.0375 0.1275)
+(-0.0060 0.0405 0.1275)
+(-0.0030 0.0405 0.1275)
+(0.0000 0.0405 0.1275)
+(0.0030 0.0405 0.1275)
+(0.0060 0.0405 0.1275)
+(-0.0060 0.0435 0.1275)
+(-0.0030 0.0435 0.1275)
+(0.0000 0.0435 0.1275)
+(0.0030 0.0435 0.1275)
+(0.0060 0.0435 0.1275)
+(-0.0060 0.0465 0.1275)
+(-0.0030 0.0465 0.1275)
+(0.0000 0.0465 0.1275)
+(0.0030 0.0465 0.1275)
+(0.0060 0.0465 0.1275)
+(-0.0060 0.0495 0.1275)
+(-0.0030 0.0495 0.1275)
+(0.0000 0.0495 0.1275)
+(0.0030 0.0495 0.1275)
+(0.0060 0.0495 0.1275)
+(-0.0060 0.0525 0.1275)
+(-0.0030 0.0525 0.1275)
+(0.0000 0.0525 0.1275)
+(0.0030 0.0525 0.1275)
+(0.0060 0.0525 0.1275)
+(-0.0060 0.0555 0.1275)
+(-0.0030 0.0555 0.1275)
+(0.0000 0.0555 0.1275)
+(0.0030 0.0555 0.1275)
+(0.0060 0.0555 0.1275)
+(-0.0060 0.0585 0.1275)
+(-0.0030 0.0585 0.1275)
+(0.0000 0.0585 0.1275)
+(0.0030 0.0585 0.1275)
+(0.0060 0.0585 0.1275)
+(-0.0060 0.0615 0.1275)
+(-0.0030 0.0615 0.1275)
+(0.0000 0.0615 0.1275)
+(0.0030 0.0615 0.1275)
+(0.0060 0.0615 0.1275)
+(-0.0060 0.0645 0.1275)
+(-0.0030 0.0645 0.1275)
+(0.0000 0.0645 0.1275)
+(0.0030 0.0645 0.1275)
+(0.0060 0.0645 0.1275)
+(-0.0060 0.0675 0.1275)
+(-0.0030 0.0675 0.1275)
+(0.0000 0.0675 0.1275)
+(0.0030 0.0675 0.1275)
+(0.0060 0.0675 0.1275)
+(-0.0060 0.0705 0.1275)
+(-0.0030 0.0705 0.1275)
+(0.0000 0.0705 0.1275)
+(0.0030 0.0705 0.1275)
+(0.0060 0.0705 0.1275)
+(-0.0060 0.0735 0.1275)
+(-0.0030 0.0735 0.1275)
+(0.0000 0.0735 0.1275)
+(0.0030 0.0735 0.1275)
+(0.0060 0.0735 0.1275)
+(-0.0060 -0.0735 0.1305)
+(-0.0030 -0.0735 0.1305)
+(0.0000 -0.0735 0.1305)
+(0.0030 -0.0735 0.1305)
+(0.0060 -0.0735 0.1305)
+(-0.0060 -0.0705 0.1305)
+(-0.0030 -0.0705 0.1305)
+(0.0000 -0.0705 0.1305)
+(0.0030 -0.0705 0.1305)
+(0.0060 -0.0705 0.1305)
+(-0.0060 -0.0675 0.1305)
+(-0.0030 -0.0675 0.1305)
+(0.0000 -0.0675 0.1305)
+(0.0030 -0.0675 0.1305)
+(0.0060 -0.0675 0.1305)
+(-0.0060 -0.0645 0.1305)
+(-0.0030 -0.0645 0.1305)
+(0.0000 -0.0645 0.1305)
+(0.0030 -0.0645 0.1305)
+(0.0060 -0.0645 0.1305)
+(-0.0060 -0.0615 0.1305)
+(-0.0030 -0.0615 0.1305)
+(0.0000 -0.0615 0.1305)
+(0.0030 -0.0615 0.1305)
+(0.0060 -0.0615 0.1305)
+(-0.0060 -0.0585 0.1305)
+(-0.0030 -0.0585 0.1305)
+(0.0000 -0.0585 0.1305)
+(0.0030 -0.0585 0.1305)
+(0.0060 -0.0585 0.1305)
+(-0.0060 -0.0555 0.1305)
+(-0.0030 -0.0555 0.1305)
+(0.0000 -0.0555 0.1305)
+(0.0030 -0.0555 0.1305)
+(0.0060 -0.0555 0.1305)
+(-0.0060 -0.0525 0.1305)
+(-0.0030 -0.0525 0.1305)
+(0.0000 -0.0525 0.1305)
+(0.0030 -0.0525 0.1305)
+(0.0060 -0.0525 0.1305)
+(-0.0060 -0.0495 0.1305)
+(-0.0030 -0.0495 0.1305)
+(0.0000 -0.0495 0.1305)
+(0.0030 -0.0495 0.1305)
+(0.0060 -0.0495 0.1305)
+(-0.0060 -0.0465 0.1305)
+(-0.0030 -0.0465 0.1305)
+(0.0000 -0.0465 0.1305)
+(0.0030 -0.0465 0.1305)
+(0.0060 -0.0465 0.1305)
+(-0.0060 -0.0435 0.1305)
+(-0.0030 -0.0435 0.1305)
+(0.0000 -0.0435 0.1305)
+(0.0030 -0.0435 0.1305)
+(0.0060 -0.0435 0.1305)
+(-0.0060 -0.0405 0.1305)
+(-0.0030 -0.0405 0.1305)
+(0.0000 -0.0405 0.1305)
+(0.0030 -0.0405 0.1305)
+(0.0060 -0.0405 0.1305)
+(-0.0060 -0.0375 0.1305)
+(-0.0030 -0.0375 0.1305)
+(0.0000 -0.0375 0.1305)
+(0.0030 -0.0375 0.1305)
+(0.0060 -0.0375 0.1305)
+(-0.0060 -0.0345 0.1305)
+(-0.0030 -0.0345 0.1305)
+(0.0000 -0.0345 0.1305)
+(0.0030 -0.0345 0.1305)
+(0.0060 -0.0345 0.1305)
+(-0.0060 -0.0315 0.1305)
+(-0.0030 -0.0315 0.1305)
+(0.0000 -0.0315 0.1305)
+(0.0030 -0.0315 0.1305)
+(0.0060 -0.0315 0.1305)
+(-0.0060 -0.0285 0.1305)
+(-0.0030 -0.0285 0.1305)
+(0.0000 -0.0285 0.1305)
+(0.0030 -0.0285 0.1305)
+(0.0060 -0.0285 0.1305)
+(-0.0060 -0.0255 0.1305)
+(-0.0030 -0.0255 0.1305)
+(0.0000 -0.0255 0.1305)
+(0.0030 -0.0255 0.1305)
+(0.0060 -0.0255 0.1305)
+(-0.0060 -0.0225 0.1305)
+(-0.0030 -0.0225 0.1305)
+(0.0000 -0.0225 0.1305)
+(0.0030 -0.0225 0.1305)
+(0.0060 -0.0225 0.1305)
+(-0.0060 -0.0195 0.1305)
+(-0.0030 -0.0195 0.1305)
+(0.0000 -0.0195 0.1305)
+(0.0030 -0.0195 0.1305)
+(0.0060 -0.0195 0.1305)
+(-0.0060 -0.0165 0.1305)
+(-0.0030 -0.0165 0.1305)
+(0.0000 -0.0165 0.1305)
+(0.0030 -0.0165 0.1305)
+(0.0060 -0.0165 0.1305)
+(-0.0060 -0.0135 0.1305)
+(-0.0030 -0.0135 0.1305)
+(0.0000 -0.0135 0.1305)
+(0.0030 -0.0135 0.1305)
+(0.0060 -0.0135 0.1305)
+(-0.0060 -0.0105 0.1305)
+(-0.0030 -0.0105 0.1305)
+(0.0000 -0.0105 0.1305)
+(0.0030 -0.0105 0.1305)
+(0.0060 -0.0105 0.1305)
+(-0.0060 -0.0075 0.1305)
+(-0.0030 -0.0075 0.1305)
+(0.0000 -0.0075 0.1305)
+(0.0030 -0.0075 0.1305)
+(0.0060 -0.0075 0.1305)
+(-0.0060 -0.0045 0.1305)
+(-0.0030 -0.0045 0.1305)
+(0.0000 -0.0045 0.1305)
+(0.0030 -0.0045 0.1305)
+(0.0060 -0.0045 0.1305)
+(-0.0060 -0.0015 0.1305)
+(-0.0030 -0.0015 0.1305)
+(0.0000 -0.0015 0.1305)
+(0.0030 -0.0015 0.1305)
+(0.0060 -0.0015 0.1305)
+(-0.0060 0.0015 0.1305)
+(-0.0030 0.0015 0.1305)
+(0.0000 0.0015 0.1305)
+(0.0030 0.0015 0.1305)
+(0.0060 0.0015 0.1305)
+(-0.0060 0.0045 0.1305)
+(-0.0030 0.0045 0.1305)
+(0.0000 0.0045 0.1305)
+(0.0030 0.0045 0.1305)
+(0.0060 0.0045 0.1305)
+(-0.0060 0.0075 0.1305)
+(-0.0030 0.0075 0.1305)
+(0.0000 0.0075 0.1305)
+(0.0030 0.0075 0.1305)
+(0.0060 0.0075 0.1305)
+(-0.0060 0.0105 0.1305)
+(-0.0030 0.0105 0.1305)
+(0.0000 0.0105 0.1305)
+(0.0030 0.0105 0.1305)
+(0.0060 0.0105 0.1305)
+(-0.0060 0.0135 0.1305)
+(-0.0030 0.0135 0.1305)
+(0.0000 0.0135 0.1305)
+(0.0030 0.0135 0.1305)
+(0.0060 0.0135 0.1305)
+(-0.0060 0.0165 0.1305)
+(-0.0030 0.0165 0.1305)
+(0.0000 0.0165 0.1305)
+(0.0030 0.0165 0.1305)
+(0.0060 0.0165 0.1305)
+(-0.0060 0.0195 0.1305)
+(-0.0030 0.0195 0.1305)
+(0.0000 0.0195 0.1305)
+(0.0030 0.0195 0.1305)
+(0.0060 0.0195 0.1305)
+(-0.0060 0.0225 0.1305)
+(-0.0030 0.0225 0.1305)
+(0.0000 0.0225 0.1305)
+(0.0030 0.0225 0.1305)
+(0.0060 0.0225 0.1305)
+(-0.0060 0.0255 0.1305)
+(-0.0030 0.0255 0.1305)
+(0.0000 0.0255 0.1305)
+(0.0030 0.0255 0.1305)
+(0.0060 0.0255 0.1305)
+(-0.0060 0.0285 0.1305)
+(-0.0030 0.0285 0.1305)
+(0.0000 0.0285 0.1305)
+(0.0030 0.0285 0.1305)
+(0.0060 0.0285 0.1305)
+(-0.0060 0.0315 0.1305)
+(-0.0030 0.0315 0.1305)
+(0.0000 0.0315 0.1305)
+(0.0030 0.0315 0.1305)
+(0.0060 0.0315 0.1305)
+(-0.0060 0.0345 0.1305)
+(-0.0030 0.0345 0.1305)
+(0.0000 0.0345 0.1305)
+(0.0030 0.0345 0.1305)
+(0.0060 0.0345 0.1305)
+(-0.0060 0.0375 0.1305)
+(-0.0030 0.0375 0.1305)
+(0.0000 0.0375 0.1305)
+(0.0030 0.0375 0.1305)
+(0.0060 0.0375 0.1305)
+(-0.0060 0.0405 0.1305)
+(-0.0030 0.0405 0.1305)
+(0.0000 0.0405 0.1305)
+(0.0030 0.0405 0.1305)
+(0.0060 0.0405 0.1305)
+(-0.0060 0.0435 0.1305)
+(-0.0030 0.0435 0.1305)
+(0.0000 0.0435 0.1305)
+(0.0030 0.0435 0.1305)
+(0.0060 0.0435 0.1305)
+(-0.0060 0.0465 0.1305)
+(-0.0030 0.0465 0.1305)
+(0.0000 0.0465 0.1305)
+(0.0030 0.0465 0.1305)
+(0.0060 0.0465 0.1305)
+(-0.0060 0.0495 0.1305)
+(-0.0030 0.0495 0.1305)
+(0.0000 0.0495 0.1305)
+(0.0030 0.0495 0.1305)
+(0.0060 0.0495 0.1305)
+(-0.0060 0.0525 0.1305)
+(-0.0030 0.0525 0.1305)
+(0.0000 0.0525 0.1305)
+(0.0030 0.0525 0.1305)
+(0.0060 0.0525 0.1305)
+(-0.0060 0.0555 0.1305)
+(-0.0030 0.0555 0.1305)
+(0.0000 0.0555 0.1305)
+(0.0030 0.0555 0.1305)
+(0.0060 0.0555 0.1305)
+(-0.0060 0.0585 0.1305)
+(-0.0030 0.0585 0.1305)
+(0.0000 0.0585 0.1305)
+(0.0030 0.0585 0.1305)
+(0.0060 0.0585 0.1305)
+(-0.0060 0.0615 0.1305)
+(-0.0030 0.0615 0.1305)
+(0.0000 0.0615 0.1305)
+(0.0030 0.0615 0.1305)
+(0.0060 0.0615 0.1305)
+(-0.0060 0.0645 0.1305)
+(-0.0030 0.0645 0.1305)
+(0.0000 0.0645 0.1305)
+(0.0030 0.0645 0.1305)
+(0.0060 0.0645 0.1305)
+(-0.0060 0.0675 0.1305)
+(-0.0030 0.0675 0.1305)
+(0.0000 0.0675 0.1305)
+(0.0030 0.0675 0.1305)
+(0.0060 0.0675 0.1305)
+(-0.0060 0.0705 0.1305)
+(-0.0030 0.0705 0.1305)
+(0.0000 0.0705 0.1305)
+(0.0030 0.0705 0.1305)
+(0.0060 0.0705 0.1305)
+(-0.0060 0.0735 0.1305)
+(-0.0030 0.0735 0.1305)
+(0.0000 0.0735 0.1305)
+(0.0030 0.0735 0.1305)
+(0.0060 0.0735 0.1305)
+(-0.0060 -0.0735 0.1335)
+(-0.0030 -0.0735 0.1335)
+(0.0000 -0.0735 0.1335)
+(0.0030 -0.0735 0.1335)
+(0.0060 -0.0735 0.1335)
+(-0.0060 -0.0705 0.1335)
+(-0.0030 -0.0705 0.1335)
+(0.0000 -0.0705 0.1335)
+(0.0030 -0.0705 0.1335)
+(0.0060 -0.0705 0.1335)
+(-0.0060 -0.0675 0.1335)
+(-0.0030 -0.0675 0.1335)
+(0.0000 -0.0675 0.1335)
+(0.0030 -0.0675 0.1335)
+(0.0060 -0.0675 0.1335)
+(-0.0060 -0.0645 0.1335)
+(-0.0030 -0.0645 0.1335)
+(0.0000 -0.0645 0.1335)
+(0.0030 -0.0645 0.1335)
+(0.0060 -0.0645 0.1335)
+(-0.0060 -0.0615 0.1335)
+(-0.0030 -0.0615 0.1335)
+(0.0000 -0.0615 0.1335)
+(0.0030 -0.0615 0.1335)
+(0.0060 -0.0615 0.1335)
+(-0.0060 -0.0585 0.1335)
+(-0.0030 -0.0585 0.1335)
+(0.0000 -0.0585 0.1335)
+(0.0030 -0.0585 0.1335)
+(0.0060 -0.0585 0.1335)
+(-0.0060 -0.0555 0.1335)
+(-0.0030 -0.0555 0.1335)
+(0.0000 -0.0555 0.1335)
+(0.0030 -0.0555 0.1335)
+(0.0060 -0.0555 0.1335)
+(-0.0060 -0.0525 0.1335)
+(-0.0030 -0.0525 0.1335)
+(0.0000 -0.0525 0.1335)
+(0.0030 -0.0525 0.1335)
+(0.0060 -0.0525 0.1335)
+(-0.0060 -0.0495 0.1335)
+(-0.0030 -0.0495 0.1335)
+(0.0000 -0.0495 0.1335)
+(0.0030 -0.0495 0.1335)
+(0.0060 -0.0495 0.1335)
+(-0.0060 -0.0465 0.1335)
+(-0.0030 -0.0465 0.1335)
+(0.0000 -0.0465 0.1335)
+(0.0030 -0.0465 0.1335)
+(0.0060 -0.0465 0.1335)
+(-0.0060 -0.0435 0.1335)
+(-0.0030 -0.0435 0.1335)
+(0.0000 -0.0435 0.1335)
+(0.0030 -0.0435 0.1335)
+(0.0060 -0.0435 0.1335)
+(-0.0060 -0.0405 0.1335)
+(-0.0030 -0.0405 0.1335)
+(0.0000 -0.0405 0.1335)
+(0.0030 -0.0405 0.1335)
+(0.0060 -0.0405 0.1335)
+(-0.0060 -0.0375 0.1335)
+(-0.0030 -0.0375 0.1335)
+(0.0000 -0.0375 0.1335)
+(0.0030 -0.0375 0.1335)
+(0.0060 -0.0375 0.1335)
+(-0.0060 -0.0345 0.1335)
+(-0.0030 -0.0345 0.1335)
+(0.0000 -0.0345 0.1335)
+(0.0030 -0.0345 0.1335)
+(0.0060 -0.0345 0.1335)
+(-0.0060 -0.0315 0.1335)
+(-0.0030 -0.0315 0.1335)
+(0.0000 -0.0315 0.1335)
+(0.0030 -0.0315 0.1335)
+(0.0060 -0.0315 0.1335)
+(-0.0060 -0.0285 0.1335)
+(-0.0030 -0.0285 0.1335)
+(0.0000 -0.0285 0.1335)
+(0.0030 -0.0285 0.1335)
+(0.0060 -0.0285 0.1335)
+(-0.0060 -0.0255 0.1335)
+(-0.0030 -0.0255 0.1335)
+(0.0000 -0.0255 0.1335)
+(0.0030 -0.0255 0.1335)
+(0.0060 -0.0255 0.1335)
+(-0.0060 -0.0225 0.1335)
+(-0.0030 -0.0225 0.1335)
+(0.0000 -0.0225 0.1335)
+(0.0030 -0.0225 0.1335)
+(0.0060 -0.0225 0.1335)
+(-0.0060 -0.0195 0.1335)
+(-0.0030 -0.0195 0.1335)
+(0.0000 -0.0195 0.1335)
+(0.0030 -0.0195 0.1335)
+(0.0060 -0.0195 0.1335)
+(-0.0060 -0.0165 0.1335)
+(-0.0030 -0.0165 0.1335)
+(0.0000 -0.0165 0.1335)
+(0.0030 -0.0165 0.1335)
+(0.0060 -0.0165 0.1335)
+(-0.0060 -0.0135 0.1335)
+(-0.0030 -0.0135 0.1335)
+(0.0000 -0.0135 0.1335)
+(0.0030 -0.0135 0.1335)
+(0.0060 -0.0135 0.1335)
+(-0.0060 -0.0105 0.1335)
+(-0.0030 -0.0105 0.1335)
+(0.0000 -0.0105 0.1335)
+(0.0030 -0.0105 0.1335)
+(0.0060 -0.0105 0.1335)
+(-0.0060 -0.0075 0.1335)
+(-0.0030 -0.0075 0.1335)
+(0.0000 -0.0075 0.1335)
+(0.0030 -0.0075 0.1335)
+(0.0060 -0.0075 0.1335)
+(-0.0060 -0.0045 0.1335)
+(-0.0030 -0.0045 0.1335)
+(0.0000 -0.0045 0.1335)
+(0.0030 -0.0045 0.1335)
+(0.0060 -0.0045 0.1335)
+(-0.0060 -0.0015 0.1335)
+(-0.0030 -0.0015 0.1335)
+(0.0000 -0.0015 0.1335)
+(0.0030 -0.0015 0.1335)
+(0.0060 -0.0015 0.1335)
+(-0.0060 0.0015 0.1335)
+(-0.0030 0.0015 0.1335)
+(0.0000 0.0015 0.1335)
+(0.0030 0.0015 0.1335)
+(0.0060 0.0015 0.1335)
+(-0.0060 0.0045 0.1335)
+(-0.0030 0.0045 0.1335)
+(0.0000 0.0045 0.1335)
+(0.0030 0.0045 0.1335)
+(0.0060 0.0045 0.1335)
+(-0.0060 0.0075 0.1335)
+(-0.0030 0.0075 0.1335)
+(0.0000 0.0075 0.1335)
+(0.0030 0.0075 0.1335)
+(0.0060 0.0075 0.1335)
+(-0.0060 0.0105 0.1335)
+(-0.0030 0.0105 0.1335)
+(0.0000 0.0105 0.1335)
+(0.0030 0.0105 0.1335)
+(0.0060 0.0105 0.1335)
+(-0.0060 0.0135 0.1335)
+(-0.0030 0.0135 0.1335)
+(0.0000 0.0135 0.1335)
+(0.0030 0.0135 0.1335)
+(0.0060 0.0135 0.1335)
+(-0.0060 0.0165 0.1335)
+(-0.0030 0.0165 0.1335)
+(0.0000 0.0165 0.1335)
+(0.0030 0.0165 0.1335)
+(0.0060 0.0165 0.1335)
+(-0.0060 0.0195 0.1335)
+(-0.0030 0.0195 0.1335)
+(0.0000 0.0195 0.1335)
+(0.0030 0.0195 0.1335)
+(0.0060 0.0195 0.1335)
+(-0.0060 0.0225 0.1335)
+(-0.0030 0.0225 0.1335)
+(0.0000 0.0225 0.1335)
+(0.0030 0.0225 0.1335)
+(0.0060 0.0225 0.1335)
+(-0.0060 0.0255 0.1335)
+(-0.0030 0.0255 0.1335)
+(0.0000 0.0255 0.1335)
+(0.0030 0.0255 0.1335)
+(0.0060 0.0255 0.1335)
+(-0.0060 0.0285 0.1335)
+(-0.0030 0.0285 0.1335)
+(0.0000 0.0285 0.1335)
+(0.0030 0.0285 0.1335)
+(0.0060 0.0285 0.1335)
+(-0.0060 0.0315 0.1335)
+(-0.0030 0.0315 0.1335)
+(0.0000 0.0315 0.1335)
+(0.0030 0.0315 0.1335)
+(0.0060 0.0315 0.1335)
+(-0.0060 0.0345 0.1335)
+(-0.0030 0.0345 0.1335)
+(0.0000 0.0345 0.1335)
+(0.0030 0.0345 0.1335)
+(0.0060 0.0345 0.1335)
+(-0.0060 0.0375 0.1335)
+(-0.0030 0.0375 0.1335)
+(0.0000 0.0375 0.1335)
+(0.0030 0.0375 0.1335)
+(0.0060 0.0375 0.1335)
+(-0.0060 0.0405 0.1335)
+(-0.0030 0.0405 0.1335)
+(0.0000 0.0405 0.1335)
+(0.0030 0.0405 0.1335)
+(0.0060 0.0405 0.1335)
+(-0.0060 0.0435 0.1335)
+(-0.0030 0.0435 0.1335)
+(0.0000 0.0435 0.1335)
+(0.0030 0.0435 0.1335)
+(0.0060 0.0435 0.1335)
+(-0.0060 0.0465 0.1335)
+(-0.0030 0.0465 0.1335)
+(0.0000 0.0465 0.1335)
+(0.0030 0.0465 0.1335)
+(0.0060 0.0465 0.1335)
+(-0.0060 0.0495 0.1335)
+(-0.0030 0.0495 0.1335)
+(0.0000 0.0495 0.1335)
+(0.0030 0.0495 0.1335)
+(0.0060 0.0495 0.1335)
+(-0.0060 0.0525 0.1335)
+(-0.0030 0.0525 0.1335)
+(0.0000 0.0525 0.1335)
+(0.0030 0.0525 0.1335)
+(0.0060 0.0525 0.1335)
+(-0.0060 0.0555 0.1335)
+(-0.0030 0.0555 0.1335)
+(0.0000 0.0555 0.1335)
+(0.0030 0.0555 0.1335)
+(0.0060 0.0555 0.1335)
+(-0.0060 0.0585 0.1335)
+(-0.0030 0.0585 0.1335)
+(0.0000 0.0585 0.1335)
+(0.0030 0.0585 0.1335)
+(0.0060 0.0585 0.1335)
+(-0.0060 0.0615 0.1335)
+(-0.0030 0.0615 0.1335)
+(0.0000 0.0615 0.1335)
+(0.0030 0.0615 0.1335)
+(0.0060 0.0615 0.1335)
+(-0.0060 0.0645 0.1335)
+(-0.0030 0.0645 0.1335)
+(0.0000 0.0645 0.1335)
+(0.0030 0.0645 0.1335)
+(0.0060 0.0645 0.1335)
+(-0.0060 0.0675 0.1335)
+(-0.0030 0.0675 0.1335)
+(0.0000 0.0675 0.1335)
+(0.0030 0.0675 0.1335)
+(0.0060 0.0675 0.1335)
+(-0.0060 0.0705 0.1335)
+(-0.0030 0.0705 0.1335)
+(0.0000 0.0705 0.1335)
+(0.0030 0.0705 0.1335)
+(0.0060 0.0705 0.1335)
+(-0.0060 0.0735 0.1335)
+(-0.0030 0.0735 0.1335)
+(0.0000 0.0735 0.1335)
+(0.0030 0.0735 0.1335)
+(0.0060 0.0735 0.1335)
+(-0.0060 -0.0735 0.1365)
+(-0.0030 -0.0735 0.1365)
+(0.0000 -0.0735 0.1365)
+(0.0030 -0.0735 0.1365)
+(0.0060 -0.0735 0.1365)
+(-0.0060 -0.0705 0.1365)
+(-0.0030 -0.0705 0.1365)
+(0.0000 -0.0705 0.1365)
+(0.0030 -0.0705 0.1365)
+(0.0060 -0.0705 0.1365)
+(-0.0060 -0.0675 0.1365)
+(-0.0030 -0.0675 0.1365)
+(0.0000 -0.0675 0.1365)
+(0.0030 -0.0675 0.1365)
+(0.0060 -0.0675 0.1365)
+(-0.0060 -0.0645 0.1365)
+(-0.0030 -0.0645 0.1365)
+(0.0000 -0.0645 0.1365)
+(0.0030 -0.0645 0.1365)
+(0.0060 -0.0645 0.1365)
+(-0.0060 -0.0615 0.1365)
+(-0.0030 -0.0615 0.1365)
+(0.0000 -0.0615 0.1365)
+(0.0030 -0.0615 0.1365)
+(0.0060 -0.0615 0.1365)
+(-0.0060 -0.0585 0.1365)
+(-0.0030 -0.0585 0.1365)
+(0.0000 -0.0585 0.1365)
+(0.0030 -0.0585 0.1365)
+(0.0060 -0.0585 0.1365)
+(-0.0060 -0.0555 0.1365)
+(-0.0030 -0.0555 0.1365)
+(0.0000 -0.0555 0.1365)
+(0.0030 -0.0555 0.1365)
+(0.0060 -0.0555 0.1365)
+(-0.0060 -0.0525 0.1365)
+(-0.0030 -0.0525 0.1365)
+(0.0000 -0.0525 0.1365)
+(0.0030 -0.0525 0.1365)
+(0.0060 -0.0525 0.1365)
+(-0.0060 -0.0495 0.1365)
+(-0.0030 -0.0495 0.1365)
+(0.0000 -0.0495 0.1365)
+(0.0030 -0.0495 0.1365)
+(0.0060 -0.0495 0.1365)
+(-0.0060 -0.0465 0.1365)
+(-0.0030 -0.0465 0.1365)
+(0.0000 -0.0465 0.1365)
+(0.0030 -0.0465 0.1365)
+(0.0060 -0.0465 0.1365)
+(-0.0060 -0.0435 0.1365)
+(-0.0030 -0.0435 0.1365)
+(0.0000 -0.0435 0.1365)
+(0.0030 -0.0435 0.1365)
+(0.0060 -0.0435 0.1365)
+(-0.0060 -0.0405 0.1365)
+(-0.0030 -0.0405 0.1365)
+(0.0000 -0.0405 0.1365)
+(0.0030 -0.0405 0.1365)
+(0.0060 -0.0405 0.1365)
+(-0.0060 -0.0375 0.1365)
+(-0.0030 -0.0375 0.1365)
+(0.0000 -0.0375 0.1365)
+(0.0030 -0.0375 0.1365)
+(0.0060 -0.0375 0.1365)
+(-0.0060 -0.0345 0.1365)
+(-0.0030 -0.0345 0.1365)
+(0.0000 -0.0345 0.1365)
+(0.0030 -0.0345 0.1365)
+(0.0060 -0.0345 0.1365)
+(-0.0060 -0.0315 0.1365)
+(-0.0030 -0.0315 0.1365)
+(0.0000 -0.0315 0.1365)
+(0.0030 -0.0315 0.1365)
+(0.0060 -0.0315 0.1365)
+(-0.0060 -0.0285 0.1365)
+(-0.0030 -0.0285 0.1365)
+(0.0000 -0.0285 0.1365)
+(0.0030 -0.0285 0.1365)
+(0.0060 -0.0285 0.1365)
+(-0.0060 -0.0255 0.1365)
+(-0.0030 -0.0255 0.1365)
+(0.0000 -0.0255 0.1365)
+(0.0030 -0.0255 0.1365)
+(0.0060 -0.0255 0.1365)
+(-0.0060 -0.0225 0.1365)
+(-0.0030 -0.0225 0.1365)
+(0.0000 -0.0225 0.1365)
+(0.0030 -0.0225 0.1365)
+(0.0060 -0.0225 0.1365)
+(-0.0060 -0.0195 0.1365)
+(-0.0030 -0.0195 0.1365)
+(0.0000 -0.0195 0.1365)
+(0.0030 -0.0195 0.1365)
+(0.0060 -0.0195 0.1365)
+(-0.0060 -0.0165 0.1365)
+(-0.0030 -0.0165 0.1365)
+(0.0000 -0.0165 0.1365)
+(0.0030 -0.0165 0.1365)
+(0.0060 -0.0165 0.1365)
+(-0.0060 -0.0135 0.1365)
+(-0.0030 -0.0135 0.1365)
+(0.0000 -0.0135 0.1365)
+(0.0030 -0.0135 0.1365)
+(0.0060 -0.0135 0.1365)
+(-0.0060 -0.0105 0.1365)
+(-0.0030 -0.0105 0.1365)
+(0.0000 -0.0105 0.1365)
+(0.0030 -0.0105 0.1365)
+(0.0060 -0.0105 0.1365)
+(-0.0060 -0.0075 0.1365)
+(-0.0030 -0.0075 0.1365)
+(0.0000 -0.0075 0.1365)
+(0.0030 -0.0075 0.1365)
+(0.0060 -0.0075 0.1365)
+(-0.0060 -0.0045 0.1365)
+(-0.0030 -0.0045 0.1365)
+(0.0000 -0.0045 0.1365)
+(0.0030 -0.0045 0.1365)
+(0.0060 -0.0045 0.1365)
+(-0.0060 -0.0015 0.1365)
+(-0.0030 -0.0015 0.1365)
+(0.0000 -0.0015 0.1365)
+(0.0030 -0.0015 0.1365)
+(0.0060 -0.0015 0.1365)
+(-0.0060 0.0015 0.1365)
+(-0.0030 0.0015 0.1365)
+(0.0000 0.0015 0.1365)
+(0.0030 0.0015 0.1365)
+(0.0060 0.0015 0.1365)
+(-0.0060 0.0045 0.1365)
+(-0.0030 0.0045 0.1365)
+(0.0000 0.0045 0.1365)
+(0.0030 0.0045 0.1365)
+(0.0060 0.0045 0.1365)
+(-0.0060 0.0075 0.1365)
+(-0.0030 0.0075 0.1365)
+(0.0000 0.0075 0.1365)
+(0.0030 0.0075 0.1365)
+(0.0060 0.0075 0.1365)
+(-0.0060 0.0105 0.1365)
+(-0.0030 0.0105 0.1365)
+(0.0000 0.0105 0.1365)
+(0.0030 0.0105 0.1365)
+(0.0060 0.0105 0.1365)
+(-0.0060 0.0135 0.1365)
+(-0.0030 0.0135 0.1365)
+(0.0000 0.0135 0.1365)
+(0.0030 0.0135 0.1365)
+(0.0060 0.0135 0.1365)
+(-0.0060 0.0165 0.1365)
+(-0.0030 0.0165 0.1365)
+(0.0000 0.0165 0.1365)
+(0.0030 0.0165 0.1365)
+(0.0060 0.0165 0.1365)
+(-0.0060 0.0195 0.1365)
+(-0.0030 0.0195 0.1365)
+(0.0000 0.0195 0.1365)
+(0.0030 0.0195 0.1365)
+(0.0060 0.0195 0.1365)
+(-0.0060 0.0225 0.1365)
+(-0.0030 0.0225 0.1365)
+(0.0000 0.0225 0.1365)
+(0.0030 0.0225 0.1365)
+(0.0060 0.0225 0.1365)
+(-0.0060 0.0255 0.1365)
+(-0.0030 0.0255 0.1365)
+(0.0000 0.0255 0.1365)
+(0.0030 0.0255 0.1365)
+(0.0060 0.0255 0.1365)
+(-0.0060 0.0285 0.1365)
+(-0.0030 0.0285 0.1365)
+(0.0000 0.0285 0.1365)
+(0.0030 0.0285 0.1365)
+(0.0060 0.0285 0.1365)
+(-0.0060 0.0315 0.1365)
+(-0.0030 0.0315 0.1365)
+(0.0000 0.0315 0.1365)
+(0.0030 0.0315 0.1365)
+(0.0060 0.0315 0.1365)
+(-0.0060 0.0345 0.1365)
+(-0.0030 0.0345 0.1365)
+(0.0000 0.0345 0.1365)
+(0.0030 0.0345 0.1365)
+(0.0060 0.0345 0.1365)
+(-0.0060 0.0375 0.1365)
+(-0.0030 0.0375 0.1365)
+(0.0000 0.0375 0.1365)
+(0.0030 0.0375 0.1365)
+(0.0060 0.0375 0.1365)
+(-0.0060 0.0405 0.1365)
+(-0.0030 0.0405 0.1365)
+(0.0000 0.0405 0.1365)
+(0.0030 0.0405 0.1365)
+(0.0060 0.0405 0.1365)
+(-0.0060 0.0435 0.1365)
+(-0.0030 0.0435 0.1365)
+(0.0000 0.0435 0.1365)
+(0.0030 0.0435 0.1365)
+(0.0060 0.0435 0.1365)
+(-0.0060 0.0465 0.1365)
+(-0.0030 0.0465 0.1365)
+(0.0000 0.0465 0.1365)
+(0.0030 0.0465 0.1365)
+(0.0060 0.0465 0.1365)
+(-0.0060 0.0495 0.1365)
+(-0.0030 0.0495 0.1365)
+(0.0000 0.0495 0.1365)
+(0.0030 0.0495 0.1365)
+(0.0060 0.0495 0.1365)
+(-0.0060 0.0525 0.1365)
+(-0.0030 0.0525 0.1365)
+(0.0000 0.0525 0.1365)
+(0.0030 0.0525 0.1365)
+(0.0060 0.0525 0.1365)
+(-0.0060 0.0555 0.1365)
+(-0.0030 0.0555 0.1365)
+(0.0000 0.0555 0.1365)
+(0.0030 0.0555 0.1365)
+(0.0060 0.0555 0.1365)
+(-0.0060 0.0585 0.1365)
+(-0.0030 0.0585 0.1365)
+(0.0000 0.0585 0.1365)
+(0.0030 0.0585 0.1365)
+(0.0060 0.0585 0.1365)
+(-0.0060 0.0615 0.1365)
+(-0.0030 0.0615 0.1365)
+(0.0000 0.0615 0.1365)
+(0.0030 0.0615 0.1365)
+(0.0060 0.0615 0.1365)
+(-0.0060 0.0645 0.1365)
+(-0.0030 0.0645 0.1365)
+(0.0000 0.0645 0.1365)
+(0.0030 0.0645 0.1365)
+(0.0060 0.0645 0.1365)
+(-0.0060 0.0675 0.1365)
+(-0.0030 0.0675 0.1365)
+(0.0000 0.0675 0.1365)
+(0.0030 0.0675 0.1365)
+(0.0060 0.0675 0.1365)
+(-0.0060 0.0705 0.1365)
+(-0.0030 0.0705 0.1365)
+(0.0000 0.0705 0.1365)
+(0.0030 0.0705 0.1365)
+(0.0060 0.0705 0.1365)
+(-0.0060 0.0735 0.1365)
+(-0.0030 0.0735 0.1365)
+(0.0000 0.0735 0.1365)
+(0.0030 0.0735 0.1365)
+(0.0060 0.0735 0.1365)
+(-0.0060 -0.0735 0.1395)
+(-0.0030 -0.0735 0.1395)
+(0.0000 -0.0735 0.1395)
+(0.0030 -0.0735 0.1395)
+(0.0060 -0.0735 0.1395)
+(-0.0060 -0.0705 0.1395)
+(-0.0030 -0.0705 0.1395)
+(0.0000 -0.0705 0.1395)
+(0.0030 -0.0705 0.1395)
+(0.0060 -0.0705 0.1395)
+(-0.0060 -0.0675 0.1395)
+(-0.0030 -0.0675 0.1395)
+(0.0000 -0.0675 0.1395)
+(0.0030 -0.0675 0.1395)
+(0.0060 -0.0675 0.1395)
+(-0.0060 -0.0645 0.1395)
+(-0.0030 -0.0645 0.1395)
+(0.0000 -0.0645 0.1395)
+(0.0030 -0.0645 0.1395)
+(0.0060 -0.0645 0.1395)
+(-0.0060 -0.0615 0.1395)
+(-0.0030 -0.0615 0.1395)
+(0.0000 -0.0615 0.1395)
+(0.0030 -0.0615 0.1395)
+(0.0060 -0.0615 0.1395)
+(-0.0060 -0.0585 0.1395)
+(-0.0030 -0.0585 0.1395)
+(0.0000 -0.0585 0.1395)
+(0.0030 -0.0585 0.1395)
+(0.0060 -0.0585 0.1395)
+(-0.0060 -0.0555 0.1395)
+(-0.0030 -0.0555 0.1395)
+(0.0000 -0.0555 0.1395)
+(0.0030 -0.0555 0.1395)
+(0.0060 -0.0555 0.1395)
+(-0.0060 -0.0525 0.1395)
+(-0.0030 -0.0525 0.1395)
+(0.0000 -0.0525 0.1395)
+(0.0030 -0.0525 0.1395)
+(0.0060 -0.0525 0.1395)
+(-0.0060 -0.0495 0.1395)
+(-0.0030 -0.0495 0.1395)
+(0.0000 -0.0495 0.1395)
+(0.0030 -0.0495 0.1395)
+(0.0060 -0.0495 0.1395)
+(-0.0060 -0.0465 0.1395)
+(-0.0030 -0.0465 0.1395)
+(0.0000 -0.0465 0.1395)
+(0.0030 -0.0465 0.1395)
+(0.0060 -0.0465 0.1395)
+(-0.0060 -0.0435 0.1395)
+(-0.0030 -0.0435 0.1395)
+(0.0000 -0.0435 0.1395)
+(0.0030 -0.0435 0.1395)
+(0.0060 -0.0435 0.1395)
+(-0.0060 -0.0405 0.1395)
+(-0.0030 -0.0405 0.1395)
+(0.0000 -0.0405 0.1395)
+(0.0030 -0.0405 0.1395)
+(0.0060 -0.0405 0.1395)
+(-0.0060 -0.0375 0.1395)
+(-0.0030 -0.0375 0.1395)
+(0.0000 -0.0375 0.1395)
+(0.0030 -0.0375 0.1395)
+(0.0060 -0.0375 0.1395)
+(-0.0060 -0.0345 0.1395)
+(-0.0030 -0.0345 0.1395)
+(0.0000 -0.0345 0.1395)
+(0.0030 -0.0345 0.1395)
+(0.0060 -0.0345 0.1395)
+(-0.0060 -0.0315 0.1395)
+(-0.0030 -0.0315 0.1395)
+(0.0000 -0.0315 0.1395)
+(0.0030 -0.0315 0.1395)
+(0.0060 -0.0315 0.1395)
+(-0.0060 -0.0285 0.1395)
+(-0.0030 -0.0285 0.1395)
+(0.0000 -0.0285 0.1395)
+(0.0030 -0.0285 0.1395)
+(0.0060 -0.0285 0.1395)
+(-0.0060 -0.0255 0.1395)
+(-0.0030 -0.0255 0.1395)
+(0.0000 -0.0255 0.1395)
+(0.0030 -0.0255 0.1395)
+(0.0060 -0.0255 0.1395)
+(-0.0060 -0.0225 0.1395)
+(-0.0030 -0.0225 0.1395)
+(0.0000 -0.0225 0.1395)
+(0.0030 -0.0225 0.1395)
+(0.0060 -0.0225 0.1395)
+(-0.0060 -0.0195 0.1395)
+(-0.0030 -0.0195 0.1395)
+(0.0000 -0.0195 0.1395)
+(0.0030 -0.0195 0.1395)
+(0.0060 -0.0195 0.1395)
+(-0.0060 -0.0165 0.1395)
+(-0.0030 -0.0165 0.1395)
+(0.0000 -0.0165 0.1395)
+(0.0030 -0.0165 0.1395)
+(0.0060 -0.0165 0.1395)
+(-0.0060 -0.0135 0.1395)
+(-0.0030 -0.0135 0.1395)
+(0.0000 -0.0135 0.1395)
+(0.0030 -0.0135 0.1395)
+(0.0060 -0.0135 0.1395)
+(-0.0060 -0.0105 0.1395)
+(-0.0030 -0.0105 0.1395)
+(0.0000 -0.0105 0.1395)
+(0.0030 -0.0105 0.1395)
+(0.0060 -0.0105 0.1395)
+(-0.0060 -0.0075 0.1395)
+(-0.0030 -0.0075 0.1395)
+(0.0000 -0.0075 0.1395)
+(0.0030 -0.0075 0.1395)
+(0.0060 -0.0075 0.1395)
+(-0.0060 -0.0045 0.1395)
+(-0.0030 -0.0045 0.1395)
+(0.0000 -0.0045 0.1395)
+(0.0030 -0.0045 0.1395)
+(0.0060 -0.0045 0.1395)
+(-0.0060 -0.0015 0.1395)
+(-0.0030 -0.0015 0.1395)
+(0.0000 -0.0015 0.1395)
+(0.0030 -0.0015 0.1395)
+(0.0060 -0.0015 0.1395)
+(-0.0060 0.0015 0.1395)
+(-0.0030 0.0015 0.1395)
+(0.0000 0.0015 0.1395)
+(0.0030 0.0015 0.1395)
+(0.0060 0.0015 0.1395)
+(-0.0060 0.0045 0.1395)
+(-0.0030 0.0045 0.1395)
+(0.0000 0.0045 0.1395)
+(0.0030 0.0045 0.1395)
+(0.0060 0.0045 0.1395)
+(-0.0060 0.0075 0.1395)
+(-0.0030 0.0075 0.1395)
+(0.0000 0.0075 0.1395)
+(0.0030 0.0075 0.1395)
+(0.0060 0.0075 0.1395)
+(-0.0060 0.0105 0.1395)
+(-0.0030 0.0105 0.1395)
+(0.0000 0.0105 0.1395)
+(0.0030 0.0105 0.1395)
+(0.0060 0.0105 0.1395)
+(-0.0060 0.0135 0.1395)
+(-0.0030 0.0135 0.1395)
+(0.0000 0.0135 0.1395)
+(0.0030 0.0135 0.1395)
+(0.0060 0.0135 0.1395)
+(-0.0060 0.0165 0.1395)
+(-0.0030 0.0165 0.1395)
+(0.0000 0.0165 0.1395)
+(0.0030 0.0165 0.1395)
+(0.0060 0.0165 0.1395)
+(-0.0060 0.0195 0.1395)
+(-0.0030 0.0195 0.1395)
+(0.0000 0.0195 0.1395)
+(0.0030 0.0195 0.1395)
+(0.0060 0.0195 0.1395)
+(-0.0060 0.0225 0.1395)
+(-0.0030 0.0225 0.1395)
+(0.0000 0.0225 0.1395)
+(0.0030 0.0225 0.1395)
+(0.0060 0.0225 0.1395)
+(-0.0060 0.0255 0.1395)
+(-0.0030 0.0255 0.1395)
+(0.0000 0.0255 0.1395)
+(0.0030 0.0255 0.1395)
+(0.0060 0.0255 0.1395)
+(-0.0060 0.0285 0.1395)
+(-0.0030 0.0285 0.1395)
+(0.0000 0.0285 0.1395)
+(0.0030 0.0285 0.1395)
+(0.0060 0.0285 0.1395)
+(-0.0060 0.0315 0.1395)
+(-0.0030 0.0315 0.1395)
+(0.0000 0.0315 0.1395)
+(0.0030 0.0315 0.1395)
+(0.0060 0.0315 0.1395)
+(-0.0060 0.0345 0.1395)
+(-0.0030 0.0345 0.1395)
+(0.0000 0.0345 0.1395)
+(0.0030 0.0345 0.1395)
+(0.0060 0.0345 0.1395)
+(-0.0060 0.0375 0.1395)
+(-0.0030 0.0375 0.1395)
+(0.0000 0.0375 0.1395)
+(0.0030 0.0375 0.1395)
+(0.0060 0.0375 0.1395)
+(-0.0060 0.0405 0.1395)
+(-0.0030 0.0405 0.1395)
+(0.0000 0.0405 0.1395)
+(0.0030 0.0405 0.1395)
+(0.0060 0.0405 0.1395)
+(-0.0060 0.0435 0.1395)
+(-0.0030 0.0435 0.1395)
+(0.0000 0.0435 0.1395)
+(0.0030 0.0435 0.1395)
+(0.0060 0.0435 0.1395)
+(-0.0060 0.0465 0.1395)
+(-0.0030 0.0465 0.1395)
+(0.0000 0.0465 0.1395)
+(0.0030 0.0465 0.1395)
+(0.0060 0.0465 0.1395)
+(-0.0060 0.0495 0.1395)
+(-0.0030 0.0495 0.1395)
+(0.0000 0.0495 0.1395)
+(0.0030 0.0495 0.1395)
+(0.0060 0.0495 0.1395)
+(-0.0060 0.0525 0.1395)
+(-0.0030 0.0525 0.1395)
+(0.0000 0.0525 0.1395)
+(0.0030 0.0525 0.1395)
+(0.0060 0.0525 0.1395)
+(-0.0060 0.0555 0.1395)
+(-0.0030 0.0555 0.1395)
+(0.0000 0.0555 0.1395)
+(0.0030 0.0555 0.1395)
+(0.0060 0.0555 0.1395)
+(-0.0060 0.0585 0.1395)
+(-0.0030 0.0585 0.1395)
+(0.0000 0.0585 0.1395)
+(0.0030 0.0585 0.1395)
+(0.0060 0.0585 0.1395)
+(-0.0060 0.0615 0.1395)
+(-0.0030 0.0615 0.1395)
+(0.0000 0.0615 0.1395)
+(0.0030 0.0615 0.1395)
+(0.0060 0.0615 0.1395)
+(-0.0060 0.0645 0.1395)
+(-0.0030 0.0645 0.1395)
+(0.0000 0.0645 0.1395)
+(0.0030 0.0645 0.1395)
+(0.0060 0.0645 0.1395)
+(-0.0060 0.0675 0.1395)
+(-0.0030 0.0675 0.1395)
+(0.0000 0.0675 0.1395)
+(0.0030 0.0675 0.1395)
+(0.0060 0.0675 0.1395)
+(-0.0060 0.0705 0.1395)
+(-0.0030 0.0705 0.1395)
+(0.0000 0.0705 0.1395)
+(0.0030 0.0705 0.1395)
+(0.0060 0.0705 0.1395)
+(-0.0060 0.0735 0.1395)
+(-0.0030 0.0735 0.1395)
+(0.0000 0.0735 0.1395)
+(0.0030 0.0735 0.1395)
+(0.0060 0.0735 0.1395)
+(-0.0060 -0.0735 0.1425)
+(-0.0030 -0.0735 0.1425)
+(0.0000 -0.0735 0.1425)
+(0.0030 -0.0735 0.1425)
+(0.0060 -0.0735 0.1425)
+(-0.0060 -0.0705 0.1425)
+(-0.0030 -0.0705 0.1425)
+(0.0000 -0.0705 0.1425)
+(0.0030 -0.0705 0.1425)
+(0.0060 -0.0705 0.1425)
+(-0.0060 -0.0675 0.1425)
+(-0.0030 -0.0675 0.1425)
+(0.0000 -0.0675 0.1425)
+(0.0030 -0.0675 0.1425)
+(0.0060 -0.0675 0.1425)
+(-0.0060 -0.0645 0.1425)
+(-0.0030 -0.0645 0.1425)
+(0.0000 -0.0645 0.1425)
+(0.0030 -0.0645 0.1425)
+(0.0060 -0.0645 0.1425)
+(-0.0060 -0.0615 0.1425)
+(-0.0030 -0.0615 0.1425)
+(0.0000 -0.0615 0.1425)
+(0.0030 -0.0615 0.1425)
+(0.0060 -0.0615 0.1425)
+(-0.0060 -0.0585 0.1425)
+(-0.0030 -0.0585 0.1425)
+(0.0000 -0.0585 0.1425)
+(0.0030 -0.0585 0.1425)
+(0.0060 -0.0585 0.1425)
+(-0.0060 -0.0555 0.1425)
+(-0.0030 -0.0555 0.1425)
+(0.0000 -0.0555 0.1425)
+(0.0030 -0.0555 0.1425)
+(0.0060 -0.0555 0.1425)
+(-0.0060 -0.0525 0.1425)
+(-0.0030 -0.0525 0.1425)
+(0.0000 -0.0525 0.1425)
+(0.0030 -0.0525 0.1425)
+(0.0060 -0.0525 0.1425)
+(-0.0060 -0.0495 0.1425)
+(-0.0030 -0.0495 0.1425)
+(0.0000 -0.0495 0.1425)
+(0.0030 -0.0495 0.1425)
+(0.0060 -0.0495 0.1425)
+(-0.0060 -0.0465 0.1425)
+(-0.0030 -0.0465 0.1425)
+(0.0000 -0.0465 0.1425)
+(0.0030 -0.0465 0.1425)
+(0.0060 -0.0465 0.1425)
+(-0.0060 -0.0435 0.1425)
+(-0.0030 -0.0435 0.1425)
+(0.0000 -0.0435 0.1425)
+(0.0030 -0.0435 0.1425)
+(0.0060 -0.0435 0.1425)
+(-0.0060 -0.0405 0.1425)
+(-0.0030 -0.0405 0.1425)
+(0.0000 -0.0405 0.1425)
+(0.0030 -0.0405 0.1425)
+(0.0060 -0.0405 0.1425)
+(-0.0060 -0.0375 0.1425)
+(-0.0030 -0.0375 0.1425)
+(0.0000 -0.0375 0.1425)
+(0.0030 -0.0375 0.1425)
+(0.0060 -0.0375 0.1425)
+(-0.0060 -0.0345 0.1425)
+(-0.0030 -0.0345 0.1425)
+(0.0000 -0.0345 0.1425)
+(0.0030 -0.0345 0.1425)
+(0.0060 -0.0345 0.1425)
+(-0.0060 -0.0315 0.1425)
+(-0.0030 -0.0315 0.1425)
+(0.0000 -0.0315 0.1425)
+(0.0030 -0.0315 0.1425)
+(0.0060 -0.0315 0.1425)
+(-0.0060 -0.0285 0.1425)
+(-0.0030 -0.0285 0.1425)
+(0.0000 -0.0285 0.1425)
+(0.0030 -0.0285 0.1425)
+(0.0060 -0.0285 0.1425)
+(-0.0060 -0.0255 0.1425)
+(-0.0030 -0.0255 0.1425)
+(0.0000 -0.0255 0.1425)
+(0.0030 -0.0255 0.1425)
+(0.0060 -0.0255 0.1425)
+(-0.0060 -0.0225 0.1425)
+(-0.0030 -0.0225 0.1425)
+(0.0000 -0.0225 0.1425)
+(0.0030 -0.0225 0.1425)
+(0.0060 -0.0225 0.1425)
+(-0.0060 -0.0195 0.1425)
+(-0.0030 -0.0195 0.1425)
+(0.0000 -0.0195 0.1425)
+(0.0030 -0.0195 0.1425)
+(0.0060 -0.0195 0.1425)
+(-0.0060 -0.0165 0.1425)
+(-0.0030 -0.0165 0.1425)
+(0.0000 -0.0165 0.1425)
+(0.0030 -0.0165 0.1425)
+(0.0060 -0.0165 0.1425)
+(-0.0060 -0.0135 0.1425)
+(-0.0030 -0.0135 0.1425)
+(0.0000 -0.0135 0.1425)
+(0.0030 -0.0135 0.1425)
+(0.0060 -0.0135 0.1425)
+(-0.0060 -0.0105 0.1425)
+(-0.0030 -0.0105 0.1425)
+(0.0000 -0.0105 0.1425)
+(0.0030 -0.0105 0.1425)
+(0.0060 -0.0105 0.1425)
+(-0.0060 -0.0075 0.1425)
+(-0.0030 -0.0075 0.1425)
+(0.0000 -0.0075 0.1425)
+(0.0030 -0.0075 0.1425)
+(0.0060 -0.0075 0.1425)
+(-0.0060 -0.0045 0.1425)
+(-0.0030 -0.0045 0.1425)
+(0.0000 -0.0045 0.1425)
+(0.0030 -0.0045 0.1425)
+(0.0060 -0.0045 0.1425)
+(-0.0060 -0.0015 0.1425)
+(-0.0030 -0.0015 0.1425)
+(0.0000 -0.0015 0.1425)
+(0.0030 -0.0015 0.1425)
+(0.0060 -0.0015 0.1425)
+(-0.0060 0.0015 0.1425)
+(-0.0030 0.0015 0.1425)
+(0.0000 0.0015 0.1425)
+(0.0030 0.0015 0.1425)
+(0.0060 0.0015 0.1425)
+(-0.0060 0.0045 0.1425)
+(-0.0030 0.0045 0.1425)
+(0.0000 0.0045 0.1425)
+(0.0030 0.0045 0.1425)
+(0.0060 0.0045 0.1425)
+(-0.0060 0.0075 0.1425)
+(-0.0030 0.0075 0.1425)
+(0.0000 0.0075 0.1425)
+(0.0030 0.0075 0.1425)
+(0.0060 0.0075 0.1425)
+(-0.0060 0.0105 0.1425)
+(-0.0030 0.0105 0.1425)
+(0.0000 0.0105 0.1425)
+(0.0030 0.0105 0.1425)
+(0.0060 0.0105 0.1425)
+(-0.0060 0.0135 0.1425)
+(-0.0030 0.0135 0.1425)
+(0.0000 0.0135 0.1425)
+(0.0030 0.0135 0.1425)
+(0.0060 0.0135 0.1425)
+(-0.0060 0.0165 0.1425)
+(-0.0030 0.0165 0.1425)
+(0.0000 0.0165 0.1425)
+(0.0030 0.0165 0.1425)
+(0.0060 0.0165 0.1425)
+(-0.0060 0.0195 0.1425)
+(-0.0030 0.0195 0.1425)
+(0.0000 0.0195 0.1425)
+(0.0030 0.0195 0.1425)
+(0.0060 0.0195 0.1425)
+(-0.0060 0.0225 0.1425)
+(-0.0030 0.0225 0.1425)
+(0.0000 0.0225 0.1425)
+(0.0030 0.0225 0.1425)
+(0.0060 0.0225 0.1425)
+(-0.0060 0.0255 0.1425)
+(-0.0030 0.0255 0.1425)
+(0.0000 0.0255 0.1425)
+(0.0030 0.0255 0.1425)
+(0.0060 0.0255 0.1425)
+(-0.0060 0.0285 0.1425)
+(-0.0030 0.0285 0.1425)
+(0.0000 0.0285 0.1425)
+(0.0030 0.0285 0.1425)
+(0.0060 0.0285 0.1425)
+(-0.0060 0.0315 0.1425)
+(-0.0030 0.0315 0.1425)
+(0.0000 0.0315 0.1425)
+(0.0030 0.0315 0.1425)
+(0.0060 0.0315 0.1425)
+(-0.0060 0.0345 0.1425)
+(-0.0030 0.0345 0.1425)
+(0.0000 0.0345 0.1425)
+(0.0030 0.0345 0.1425)
+(0.0060 0.0345 0.1425)
+(-0.0060 0.0375 0.1425)
+(-0.0030 0.0375 0.1425)
+(0.0000 0.0375 0.1425)
+(0.0030 0.0375 0.1425)
+(0.0060 0.0375 0.1425)
+(-0.0060 0.0405 0.1425)
+(-0.0030 0.0405 0.1425)
+(0.0000 0.0405 0.1425)
+(0.0030 0.0405 0.1425)
+(0.0060 0.0405 0.1425)
+(-0.0060 0.0435 0.1425)
+(-0.0030 0.0435 0.1425)
+(0.0000 0.0435 0.1425)
+(0.0030 0.0435 0.1425)
+(0.0060 0.0435 0.1425)
+(-0.0060 0.0465 0.1425)
+(-0.0030 0.0465 0.1425)
+(0.0000 0.0465 0.1425)
+(0.0030 0.0465 0.1425)
+(0.0060 0.0465 0.1425)
+(-0.0060 0.0495 0.1425)
+(-0.0030 0.0495 0.1425)
+(0.0000 0.0495 0.1425)
+(0.0030 0.0495 0.1425)
+(0.0060 0.0495 0.1425)
+(-0.0060 0.0525 0.1425)
+(-0.0030 0.0525 0.1425)
+(0.0000 0.0525 0.1425)
+(0.0030 0.0525 0.1425)
+(0.0060 0.0525 0.1425)
+(-0.0060 0.0555 0.1425)
+(-0.0030 0.0555 0.1425)
+(0.0000 0.0555 0.1425)
+(0.0030 0.0555 0.1425)
+(0.0060 0.0555 0.1425)
+(-0.0060 0.0585 0.1425)
+(-0.0030 0.0585 0.1425)
+(0.0000 0.0585 0.1425)
+(0.0030 0.0585 0.1425)
+(0.0060 0.0585 0.1425)
+(-0.0060 0.0615 0.1425)
+(-0.0030 0.0615 0.1425)
+(0.0000 0.0615 0.1425)
+(0.0030 0.0615 0.1425)
+(0.0060 0.0615 0.1425)
+(-0.0060 0.0645 0.1425)
+(-0.0030 0.0645 0.1425)
+(0.0000 0.0645 0.1425)
+(0.0030 0.0645 0.1425)
+(0.0060 0.0645 0.1425)
+(-0.0060 0.0675 0.1425)
+(-0.0030 0.0675 0.1425)
+(0.0000 0.0675 0.1425)
+(0.0030 0.0675 0.1425)
+(0.0060 0.0675 0.1425)
+(-0.0060 0.0705 0.1425)
+(-0.0030 0.0705 0.1425)
+(0.0000 0.0705 0.1425)
+(0.0030 0.0705 0.1425)
+(0.0060 0.0705 0.1425)
+(-0.0060 0.0735 0.1425)
+(-0.0030 0.0735 0.1425)
+(0.0000 0.0735 0.1425)
+(0.0030 0.0735 0.1425)
+(0.0060 0.0735 0.1425)
+(-0.0060 -0.0735 0.1455)
+(-0.0030 -0.0735 0.1455)
+(0.0000 -0.0735 0.1455)
+(0.0030 -0.0735 0.1455)
+(0.0060 -0.0735 0.1455)
+(-0.0060 -0.0705 0.1455)
+(-0.0030 -0.0705 0.1455)
+(0.0000 -0.0705 0.1455)
+(0.0030 -0.0705 0.1455)
+(0.0060 -0.0705 0.1455)
+(-0.0060 -0.0675 0.1455)
+(-0.0030 -0.0675 0.1455)
+(0.0000 -0.0675 0.1455)
+(0.0030 -0.0675 0.1455)
+(0.0060 -0.0675 0.1455)
+(-0.0060 -0.0645 0.1455)
+(-0.0030 -0.0645 0.1455)
+(0.0000 -0.0645 0.1455)
+(0.0030 -0.0645 0.1455)
+(0.0060 -0.0645 0.1455)
+(-0.0060 -0.0615 0.1455)
+(-0.0030 -0.0615 0.1455)
+(0.0000 -0.0615 0.1455)
+(0.0030 -0.0615 0.1455)
+(0.0060 -0.0615 0.1455)
+(-0.0060 -0.0585 0.1455)
+(-0.0030 -0.0585 0.1455)
+(0.0000 -0.0585 0.1455)
+(0.0030 -0.0585 0.1455)
+(0.0060 -0.0585 0.1455)
+(-0.0060 -0.0555 0.1455)
+(-0.0030 -0.0555 0.1455)
+(0.0000 -0.0555 0.1455)
+(0.0030 -0.0555 0.1455)
+(0.0060 -0.0555 0.1455)
+(-0.0060 -0.0525 0.1455)
+(-0.0030 -0.0525 0.1455)
+(0.0000 -0.0525 0.1455)
+(0.0030 -0.0525 0.1455)
+(0.0060 -0.0525 0.1455)
+(-0.0060 -0.0495 0.1455)
+(-0.0030 -0.0495 0.1455)
+(0.0000 -0.0495 0.1455)
+(0.0030 -0.0495 0.1455)
+(0.0060 -0.0495 0.1455)
+(-0.0060 -0.0465 0.1455)
+(-0.0030 -0.0465 0.1455)
+(0.0000 -0.0465 0.1455)
+(0.0030 -0.0465 0.1455)
+(0.0060 -0.0465 0.1455)
+(-0.0060 -0.0435 0.1455)
+(-0.0030 -0.0435 0.1455)
+(0.0000 -0.0435 0.1455)
+(0.0030 -0.0435 0.1455)
+(0.0060 -0.0435 0.1455)
+(-0.0060 -0.0405 0.1455)
+(-0.0030 -0.0405 0.1455)
+(0.0000 -0.0405 0.1455)
+(0.0030 -0.0405 0.1455)
+(0.0060 -0.0405 0.1455)
+(-0.0060 -0.0375 0.1455)
+(-0.0030 -0.0375 0.1455)
+(0.0000 -0.0375 0.1455)
+(0.0030 -0.0375 0.1455)
+(0.0060 -0.0375 0.1455)
+(-0.0060 -0.0345 0.1455)
+(-0.0030 -0.0345 0.1455)
+(0.0000 -0.0345 0.1455)
+(0.0030 -0.0345 0.1455)
+(0.0060 -0.0345 0.1455)
+(-0.0060 -0.0315 0.1455)
+(-0.0030 -0.0315 0.1455)
+(0.0000 -0.0315 0.1455)
+(0.0030 -0.0315 0.1455)
+(0.0060 -0.0315 0.1455)
+(-0.0060 -0.0285 0.1455)
+(-0.0030 -0.0285 0.1455)
+(0.0000 -0.0285 0.1455)
+(0.0030 -0.0285 0.1455)
+(0.0060 -0.0285 0.1455)
+(-0.0060 -0.0255 0.1455)
+(-0.0030 -0.0255 0.1455)
+(0.0000 -0.0255 0.1455)
+(0.0030 -0.0255 0.1455)
+(0.0060 -0.0255 0.1455)
+(-0.0060 -0.0225 0.1455)
+(-0.0030 -0.0225 0.1455)
+(0.0000 -0.0225 0.1455)
+(0.0030 -0.0225 0.1455)
+(0.0060 -0.0225 0.1455)
+(-0.0060 -0.0195 0.1455)
+(-0.0030 -0.0195 0.1455)
+(0.0000 -0.0195 0.1455)
+(0.0030 -0.0195 0.1455)
+(0.0060 -0.0195 0.1455)
+(-0.0060 -0.0165 0.1455)
+(-0.0030 -0.0165 0.1455)
+(0.0000 -0.0165 0.1455)
+(0.0030 -0.0165 0.1455)
+(0.0060 -0.0165 0.1455)
+(-0.0060 -0.0135 0.1455)
+(-0.0030 -0.0135 0.1455)
+(0.0000 -0.0135 0.1455)
+(0.0030 -0.0135 0.1455)
+(0.0060 -0.0135 0.1455)
+(-0.0060 -0.0105 0.1455)
+(-0.0030 -0.0105 0.1455)
+(0.0000 -0.0105 0.1455)
+(0.0030 -0.0105 0.1455)
+(0.0060 -0.0105 0.1455)
+(-0.0060 -0.0075 0.1455)
+(-0.0030 -0.0075 0.1455)
+(0.0000 -0.0075 0.1455)
+(0.0030 -0.0075 0.1455)
+(0.0060 -0.0075 0.1455)
+(-0.0060 -0.0045 0.1455)
+(-0.0030 -0.0045 0.1455)
+(0.0000 -0.0045 0.1455)
+(0.0030 -0.0045 0.1455)
+(0.0060 -0.0045 0.1455)
+(-0.0060 -0.0015 0.1455)
+(-0.0030 -0.0015 0.1455)
+(0.0000 -0.0015 0.1455)
+(0.0030 -0.0015 0.1455)
+(0.0060 -0.0015 0.1455)
+(-0.0060 0.0015 0.1455)
+(-0.0030 0.0015 0.1455)
+(0.0000 0.0015 0.1455)
+(0.0030 0.0015 0.1455)
+(0.0060 0.0015 0.1455)
+(-0.0060 0.0045 0.1455)
+(-0.0030 0.0045 0.1455)
+(0.0000 0.0045 0.1455)
+(0.0030 0.0045 0.1455)
+(0.0060 0.0045 0.1455)
+(-0.0060 0.0075 0.1455)
+(-0.0030 0.0075 0.1455)
+(0.0000 0.0075 0.1455)
+(0.0030 0.0075 0.1455)
+(0.0060 0.0075 0.1455)
+(-0.0060 0.0105 0.1455)
+(-0.0030 0.0105 0.1455)
+(0.0000 0.0105 0.1455)
+(0.0030 0.0105 0.1455)
+(0.0060 0.0105 0.1455)
+(-0.0060 0.0135 0.1455)
+(-0.0030 0.0135 0.1455)
+(0.0000 0.0135 0.1455)
+(0.0030 0.0135 0.1455)
+(0.0060 0.0135 0.1455)
+(-0.0060 0.0165 0.1455)
+(-0.0030 0.0165 0.1455)
+(0.0000 0.0165 0.1455)
+(0.0030 0.0165 0.1455)
+(0.0060 0.0165 0.1455)
+(-0.0060 0.0195 0.1455)
+(-0.0030 0.0195 0.1455)
+(0.0000 0.0195 0.1455)
+(0.0030 0.0195 0.1455)
+(0.0060 0.0195 0.1455)
+(-0.0060 0.0225 0.1455)
+(-0.0030 0.0225 0.1455)
+(0.0000 0.0225 0.1455)
+(0.0030 0.0225 0.1455)
+(0.0060 0.0225 0.1455)
+(-0.0060 0.0255 0.1455)
+(-0.0030 0.0255 0.1455)
+(0.0000 0.0255 0.1455)
+(0.0030 0.0255 0.1455)
+(0.0060 0.0255 0.1455)
+(-0.0060 0.0285 0.1455)
+(-0.0030 0.0285 0.1455)
+(0.0000 0.0285 0.1455)
+(0.0030 0.0285 0.1455)
+(0.0060 0.0285 0.1455)
+(-0.0060 0.0315 0.1455)
+(-0.0030 0.0315 0.1455)
+(0.0000 0.0315 0.1455)
+(0.0030 0.0315 0.1455)
+(0.0060 0.0315 0.1455)
+(-0.0060 0.0345 0.1455)
+(-0.0030 0.0345 0.1455)
+(0.0000 0.0345 0.1455)
+(0.0030 0.0345 0.1455)
+(0.0060 0.0345 0.1455)
+(-0.0060 0.0375 0.1455)
+(-0.0030 0.0375 0.1455)
+(0.0000 0.0375 0.1455)
+(0.0030 0.0375 0.1455)
+(0.0060 0.0375 0.1455)
+(-0.0060 0.0405 0.1455)
+(-0.0030 0.0405 0.1455)
+(0.0000 0.0405 0.1455)
+(0.0030 0.0405 0.1455)
+(0.0060 0.0405 0.1455)
+(-0.0060 0.0435 0.1455)
+(-0.0030 0.0435 0.1455)
+(0.0000 0.0435 0.1455)
+(0.0030 0.0435 0.1455)
+(0.0060 0.0435 0.1455)
+(-0.0060 0.0465 0.1455)
+(-0.0030 0.0465 0.1455)
+(0.0000 0.0465 0.1455)
+(0.0030 0.0465 0.1455)
+(0.0060 0.0465 0.1455)
+(-0.0060 0.0495 0.1455)
+(-0.0030 0.0495 0.1455)
+(0.0000 0.0495 0.1455)
+(0.0030 0.0495 0.1455)
+(0.0060 0.0495 0.1455)
+(-0.0060 0.0525 0.1455)
+(-0.0030 0.0525 0.1455)
+(0.0000 0.0525 0.1455)
+(0.0030 0.0525 0.1455)
+(0.0060 0.0525 0.1455)
+(-0.0060 0.0555 0.1455)
+(-0.0030 0.0555 0.1455)
+(0.0000 0.0555 0.1455)
+(0.0030 0.0555 0.1455)
+(0.0060 0.0555 0.1455)
+(-0.0060 0.0585 0.1455)
+(-0.0030 0.0585 0.1455)
+(0.0000 0.0585 0.1455)
+(0.0030 0.0585 0.1455)
+(0.0060 0.0585 0.1455)
+(-0.0060 0.0615 0.1455)
+(-0.0030 0.0615 0.1455)
+(0.0000 0.0615 0.1455)
+(0.0030 0.0615 0.1455)
+(0.0060 0.0615 0.1455)
+(-0.0060 0.0645 0.1455)
+(-0.0030 0.0645 0.1455)
+(0.0000 0.0645 0.1455)
+(0.0030 0.0645 0.1455)
+(0.0060 0.0645 0.1455)
+(-0.0060 0.0675 0.1455)
+(-0.0030 0.0675 0.1455)
+(0.0000 0.0675 0.1455)
+(0.0030 0.0675 0.1455)
+(0.0060 0.0675 0.1455)
+(-0.0060 0.0705 0.1455)
+(-0.0030 0.0705 0.1455)
+(0.0000 0.0705 0.1455)
+(0.0030 0.0705 0.1455)
+(0.0060 0.0705 0.1455)
+(-0.0060 0.0735 0.1455)
+(-0.0030 0.0735 0.1455)
+(0.0000 0.0735 0.1455)
+(0.0030 0.0735 0.1455)
+(0.0060 0.0735 0.1455)
+(-0.0060 -0.0735 0.1485)
+(-0.0030 -0.0735 0.1485)
+(0.0000 -0.0735 0.1485)
+(0.0030 -0.0735 0.1485)
+(0.0060 -0.0735 0.1485)
+(-0.0060 -0.0705 0.1485)
+(-0.0030 -0.0705 0.1485)
+(0.0000 -0.0705 0.1485)
+(0.0030 -0.0705 0.1485)
+(0.0060 -0.0705 0.1485)
+(-0.0060 -0.0675 0.1485)
+(-0.0030 -0.0675 0.1485)
+(0.0000 -0.0675 0.1485)
+(0.0030 -0.0675 0.1485)
+(0.0060 -0.0675 0.1485)
+(-0.0060 -0.0645 0.1485)
+(-0.0030 -0.0645 0.1485)
+(0.0000 -0.0645 0.1485)
+(0.0030 -0.0645 0.1485)
+(0.0060 -0.0645 0.1485)
+(-0.0060 -0.0615 0.1485)
+(-0.0030 -0.0615 0.1485)
+(0.0000 -0.0615 0.1485)
+(0.0030 -0.0615 0.1485)
+(0.0060 -0.0615 0.1485)
+(-0.0060 -0.0585 0.1485)
+(-0.0030 -0.0585 0.1485)
+(0.0000 -0.0585 0.1485)
+(0.0030 -0.0585 0.1485)
+(0.0060 -0.0585 0.1485)
+(-0.0060 -0.0555 0.1485)
+(-0.0030 -0.0555 0.1485)
+(0.0000 -0.0555 0.1485)
+(0.0030 -0.0555 0.1485)
+(0.0060 -0.0555 0.1485)
+(-0.0060 -0.0525 0.1485)
+(-0.0030 -0.0525 0.1485)
+(0.0000 -0.0525 0.1485)
+(0.0030 -0.0525 0.1485)
+(0.0060 -0.0525 0.1485)
+(-0.0060 -0.0495 0.1485)
+(-0.0030 -0.0495 0.1485)
+(0.0000 -0.0495 0.1485)
+(0.0030 -0.0495 0.1485)
+(0.0060 -0.0495 0.1485)
+(-0.0060 -0.0465 0.1485)
+(-0.0030 -0.0465 0.1485)
+(0.0000 -0.0465 0.1485)
+(0.0030 -0.0465 0.1485)
+(0.0060 -0.0465 0.1485)
+(-0.0060 -0.0435 0.1485)
+(-0.0030 -0.0435 0.1485)
+(0.0000 -0.0435 0.1485)
+(0.0030 -0.0435 0.1485)
+(0.0060 -0.0435 0.1485)
+(-0.0060 -0.0405 0.1485)
+(-0.0030 -0.0405 0.1485)
+(0.0000 -0.0405 0.1485)
+(0.0030 -0.0405 0.1485)
+(0.0060 -0.0405 0.1485)
+(-0.0060 -0.0375 0.1485)
+(-0.0030 -0.0375 0.1485)
+(0.0000 -0.0375 0.1485)
+(0.0030 -0.0375 0.1485)
+(0.0060 -0.0375 0.1485)
+(-0.0060 -0.0345 0.1485)
+(-0.0030 -0.0345 0.1485)
+(0.0000 -0.0345 0.1485)
+(0.0030 -0.0345 0.1485)
+(0.0060 -0.0345 0.1485)
+(-0.0060 -0.0315 0.1485)
+(-0.0030 -0.0315 0.1485)
+(0.0000 -0.0315 0.1485)
+(0.0030 -0.0315 0.1485)
+(0.0060 -0.0315 0.1485)
+(-0.0060 -0.0285 0.1485)
+(-0.0030 -0.0285 0.1485)
+(0.0000 -0.0285 0.1485)
+(0.0030 -0.0285 0.1485)
+(0.0060 -0.0285 0.1485)
+(-0.0060 -0.0255 0.1485)
+(-0.0030 -0.0255 0.1485)
+(0.0000 -0.0255 0.1485)
+(0.0030 -0.0255 0.1485)
+(0.0060 -0.0255 0.1485)
+(-0.0060 -0.0225 0.1485)
+(-0.0030 -0.0225 0.1485)
+(0.0000 -0.0225 0.1485)
+(0.0030 -0.0225 0.1485)
+(0.0060 -0.0225 0.1485)
+(-0.0060 -0.0195 0.1485)
+(-0.0030 -0.0195 0.1485)
+(0.0000 -0.0195 0.1485)
+(0.0030 -0.0195 0.1485)
+(0.0060 -0.0195 0.1485)
+(-0.0060 -0.0165 0.1485)
+(-0.0030 -0.0165 0.1485)
+(0.0000 -0.0165 0.1485)
+(0.0030 -0.0165 0.1485)
+(0.0060 -0.0165 0.1485)
+(-0.0060 -0.0135 0.1485)
+(-0.0030 -0.0135 0.1485)
+(0.0000 -0.0135 0.1485)
+(0.0030 -0.0135 0.1485)
+(0.0060 -0.0135 0.1485)
+(-0.0060 -0.0105 0.1485)
+(-0.0030 -0.0105 0.1485)
+(0.0000 -0.0105 0.1485)
+(0.0030 -0.0105 0.1485)
+(0.0060 -0.0105 0.1485)
+(-0.0060 -0.0075 0.1485)
+(-0.0030 -0.0075 0.1485)
+(0.0000 -0.0075 0.1485)
+(0.0030 -0.0075 0.1485)
+(0.0060 -0.0075 0.1485)
+(-0.0060 -0.0045 0.1485)
+(-0.0030 -0.0045 0.1485)
+(0.0000 -0.0045 0.1485)
+(0.0030 -0.0045 0.1485)
+(0.0060 -0.0045 0.1485)
+(-0.0060 -0.0015 0.1485)
+(-0.0030 -0.0015 0.1485)
+(0.0000 -0.0015 0.1485)
+(0.0030 -0.0015 0.1485)
+(0.0060 -0.0015 0.1485)
+(-0.0060 0.0015 0.1485)
+(-0.0030 0.0015 0.1485)
+(0.0000 0.0015 0.1485)
+(0.0030 0.0015 0.1485)
+(0.0060 0.0015 0.1485)
+(-0.0060 0.0045 0.1485)
+(-0.0030 0.0045 0.1485)
+(0.0000 0.0045 0.1485)
+(0.0030 0.0045 0.1485)
+(0.0060 0.0045 0.1485)
+(-0.0060 0.0075 0.1485)
+(-0.0030 0.0075 0.1485)
+(0.0000 0.0075 0.1485)
+(0.0030 0.0075 0.1485)
+(0.0060 0.0075 0.1485)
+(-0.0060 0.0105 0.1485)
+(-0.0030 0.0105 0.1485)
+(0.0000 0.0105 0.1485)
+(0.0030 0.0105 0.1485)
+(0.0060 0.0105 0.1485)
+(-0.0060 0.0135 0.1485)
+(-0.0030 0.0135 0.1485)
+(0.0000 0.0135 0.1485)
+(0.0030 0.0135 0.1485)
+(0.0060 0.0135 0.1485)
+(-0.0060 0.0165 0.1485)
+(-0.0030 0.0165 0.1485)
+(0.0000 0.0165 0.1485)
+(0.0030 0.0165 0.1485)
+(0.0060 0.0165 0.1485)
+(-0.0060 0.0195 0.1485)
+(-0.0030 0.0195 0.1485)
+(0.0000 0.0195 0.1485)
+(0.0030 0.0195 0.1485)
+(0.0060 0.0195 0.1485)
+(-0.0060 0.0225 0.1485)
+(-0.0030 0.0225 0.1485)
+(0.0000 0.0225 0.1485)
+(0.0030 0.0225 0.1485)
+(0.0060 0.0225 0.1485)
+(-0.0060 0.0255 0.1485)
+(-0.0030 0.0255 0.1485)
+(0.0000 0.0255 0.1485)
+(0.0030 0.0255 0.1485)
+(0.0060 0.0255 0.1485)
+(-0.0060 0.0285 0.1485)
+(-0.0030 0.0285 0.1485)
+(0.0000 0.0285 0.1485)
+(0.0030 0.0285 0.1485)
+(0.0060 0.0285 0.1485)
+(-0.0060 0.0315 0.1485)
+(-0.0030 0.0315 0.1485)
+(0.0000 0.0315 0.1485)
+(0.0030 0.0315 0.1485)
+(0.0060 0.0315 0.1485)
+(-0.0060 0.0345 0.1485)
+(-0.0030 0.0345 0.1485)
+(0.0000 0.0345 0.1485)
+(0.0030 0.0345 0.1485)
+(0.0060 0.0345 0.1485)
+(-0.0060 0.0375 0.1485)
+(-0.0030 0.0375 0.1485)
+(0.0000 0.0375 0.1485)
+(0.0030 0.0375 0.1485)
+(0.0060 0.0375 0.1485)
+(-0.0060 0.0405 0.1485)
+(-0.0030 0.0405 0.1485)
+(0.0000 0.0405 0.1485)
+(0.0030 0.0405 0.1485)
+(0.0060 0.0405 0.1485)
+(-0.0060 0.0435 0.1485)
+(-0.0030 0.0435 0.1485)
+(0.0000 0.0435 0.1485)
+(0.0030 0.0435 0.1485)
+(0.0060 0.0435 0.1485)
+(-0.0060 0.0465 0.1485)
+(-0.0030 0.0465 0.1485)
+(0.0000 0.0465 0.1485)
+(0.0030 0.0465 0.1485)
+(0.0060 0.0465 0.1485)
+(-0.0060 0.0495 0.1485)
+(-0.0030 0.0495 0.1485)
+(0.0000 0.0495 0.1485)
+(0.0030 0.0495 0.1485)
+(0.0060 0.0495 0.1485)
+(-0.0060 0.0525 0.1485)
+(-0.0030 0.0525 0.1485)
+(0.0000 0.0525 0.1485)
+(0.0030 0.0525 0.1485)
+(0.0060 0.0525 0.1485)
+(-0.0060 0.0555 0.1485)
+(-0.0030 0.0555 0.1485)
+(0.0000 0.0555 0.1485)
+(0.0030 0.0555 0.1485)
+(0.0060 0.0555 0.1485)
+(-0.0060 0.0585 0.1485)
+(-0.0030 0.0585 0.1485)
+(0.0000 0.0585 0.1485)
+(0.0030 0.0585 0.1485)
+(0.0060 0.0585 0.1485)
+(-0.0060 0.0615 0.1485)
+(-0.0030 0.0615 0.1485)
+(0.0000 0.0615 0.1485)
+(0.0030 0.0615 0.1485)
+(0.0060 0.0615 0.1485)
+(-0.0060 0.0645 0.1485)
+(-0.0030 0.0645 0.1485)
+(0.0000 0.0645 0.1485)
+(0.0030 0.0645 0.1485)
+(0.0060 0.0645 0.1485)
+(-0.0060 0.0675 0.1485)
+(-0.0030 0.0675 0.1485)
+(0.0000 0.0675 0.1485)
+(0.0030 0.0675 0.1485)
+(0.0060 0.0675 0.1485)
+(-0.0060 0.0705 0.1485)
+(-0.0030 0.0705 0.1485)
+(0.0000 0.0705 0.1485)
+(0.0030 0.0705 0.1485)
+(0.0060 0.0705 0.1485)
+(-0.0060 0.0735 0.1485)
+(-0.0030 0.0735 0.1485)
+(0.0000 0.0735 0.1485)
+(0.0030 0.0735 0.1485)
+(0.0060 0.0735 0.1485)
+(-0.0060 -0.0735 0.1515)
+(-0.0030 -0.0735 0.1515)
+(0.0000 -0.0735 0.1515)
+(0.0030 -0.0735 0.1515)
+(0.0060 -0.0735 0.1515)
+(-0.0060 -0.0705 0.1515)
+(-0.0030 -0.0705 0.1515)
+(0.0000 -0.0705 0.1515)
+(0.0030 -0.0705 0.1515)
+(0.0060 -0.0705 0.1515)
+(-0.0060 -0.0675 0.1515)
+(-0.0030 -0.0675 0.1515)
+(0.0000 -0.0675 0.1515)
+(0.0030 -0.0675 0.1515)
+(0.0060 -0.0675 0.1515)
+(-0.0060 -0.0645 0.1515)
+(-0.0030 -0.0645 0.1515)
+(0.0000 -0.0645 0.1515)
+(0.0030 -0.0645 0.1515)
+(0.0060 -0.0645 0.1515)
+(-0.0060 -0.0615 0.1515)
+(-0.0030 -0.0615 0.1515)
+(0.0000 -0.0615 0.1515)
+(0.0030 -0.0615 0.1515)
+(0.0060 -0.0615 0.1515)
+(-0.0060 -0.0585 0.1515)
+(-0.0030 -0.0585 0.1515)
+(0.0000 -0.0585 0.1515)
+(0.0030 -0.0585 0.1515)
+(0.0060 -0.0585 0.1515)
+(-0.0060 -0.0555 0.1515)
+(-0.0030 -0.0555 0.1515)
+(0.0000 -0.0555 0.1515)
+(0.0030 -0.0555 0.1515)
+(0.0060 -0.0555 0.1515)
+(-0.0060 -0.0525 0.1515)
+(-0.0030 -0.0525 0.1515)
+(0.0000 -0.0525 0.1515)
+(0.0030 -0.0525 0.1515)
+(0.0060 -0.0525 0.1515)
+(-0.0060 -0.0495 0.1515)
+(-0.0030 -0.0495 0.1515)
+(0.0000 -0.0495 0.1515)
+(0.0030 -0.0495 0.1515)
+(0.0060 -0.0495 0.1515)
+(-0.0060 -0.0465 0.1515)
+(-0.0030 -0.0465 0.1515)
+(0.0000 -0.0465 0.1515)
+(0.0030 -0.0465 0.1515)
+(0.0060 -0.0465 0.1515)
+(-0.0060 -0.0435 0.1515)
+(-0.0030 -0.0435 0.1515)
+(0.0000 -0.0435 0.1515)
+(0.0030 -0.0435 0.1515)
+(0.0060 -0.0435 0.1515)
+(-0.0060 -0.0405 0.1515)
+(-0.0030 -0.0405 0.1515)
+(0.0000 -0.0405 0.1515)
+(0.0030 -0.0405 0.1515)
+(0.0060 -0.0405 0.1515)
+(-0.0060 -0.0375 0.1515)
+(-0.0030 -0.0375 0.1515)
+(0.0000 -0.0375 0.1515)
+(0.0030 -0.0375 0.1515)
+(0.0060 -0.0375 0.1515)
+(-0.0060 -0.0345 0.1515)
+(-0.0030 -0.0345 0.1515)
+(0.0000 -0.0345 0.1515)
+(0.0030 -0.0345 0.1515)
+(0.0060 -0.0345 0.1515)
+(-0.0060 -0.0315 0.1515)
+(-0.0030 -0.0315 0.1515)
+(0.0000 -0.0315 0.1515)
+(0.0030 -0.0315 0.1515)
+(0.0060 -0.0315 0.1515)
+(-0.0060 -0.0285 0.1515)
+(-0.0030 -0.0285 0.1515)
+(0.0000 -0.0285 0.1515)
+(0.0030 -0.0285 0.1515)
+(0.0060 -0.0285 0.1515)
+(-0.0060 -0.0255 0.1515)
+(-0.0030 -0.0255 0.1515)
+(0.0000 -0.0255 0.1515)
+(0.0030 -0.0255 0.1515)
+(0.0060 -0.0255 0.1515)
+(-0.0060 -0.0225 0.1515)
+(-0.0030 -0.0225 0.1515)
+(0.0000 -0.0225 0.1515)
+(0.0030 -0.0225 0.1515)
+(0.0060 -0.0225 0.1515)
+(-0.0060 -0.0195 0.1515)
+(-0.0030 -0.0195 0.1515)
+(0.0000 -0.0195 0.1515)
+(0.0030 -0.0195 0.1515)
+(0.0060 -0.0195 0.1515)
+(-0.0060 -0.0165 0.1515)
+(-0.0030 -0.0165 0.1515)
+(0.0000 -0.0165 0.1515)
+(0.0030 -0.0165 0.1515)
+(0.0060 -0.0165 0.1515)
+(-0.0060 -0.0135 0.1515)
+(-0.0030 -0.0135 0.1515)
+(0.0000 -0.0135 0.1515)
+(0.0030 -0.0135 0.1515)
+(0.0060 -0.0135 0.1515)
+(-0.0060 -0.0105 0.1515)
+(-0.0030 -0.0105 0.1515)
+(0.0000 -0.0105 0.1515)
+(0.0030 -0.0105 0.1515)
+(0.0060 -0.0105 0.1515)
+(-0.0060 -0.0075 0.1515)
+(-0.0030 -0.0075 0.1515)
+(0.0000 -0.0075 0.1515)
+(0.0030 -0.0075 0.1515)
+(0.0060 -0.0075 0.1515)
+(-0.0060 -0.0045 0.1515)
+(-0.0030 -0.0045 0.1515)
+(0.0000 -0.0045 0.1515)
+(0.0030 -0.0045 0.1515)
+(0.0060 -0.0045 0.1515)
+(-0.0060 -0.0015 0.1515)
+(-0.0030 -0.0015 0.1515)
+(0.0000 -0.0015 0.1515)
+(0.0030 -0.0015 0.1515)
+(0.0060 -0.0015 0.1515)
+(-0.0060 0.0015 0.1515)
+(-0.0030 0.0015 0.1515)
+(0.0000 0.0015 0.1515)
+(0.0030 0.0015 0.1515)
+(0.0060 0.0015 0.1515)
+(-0.0060 0.0045 0.1515)
+(-0.0030 0.0045 0.1515)
+(0.0000 0.0045 0.1515)
+(0.0030 0.0045 0.1515)
+(0.0060 0.0045 0.1515)
+(-0.0060 0.0075 0.1515)
+(-0.0030 0.0075 0.1515)
+(0.0000 0.0075 0.1515)
+(0.0030 0.0075 0.1515)
+(0.0060 0.0075 0.1515)
+(-0.0060 0.0105 0.1515)
+(-0.0030 0.0105 0.1515)
+(0.0000 0.0105 0.1515)
+(0.0030 0.0105 0.1515)
+(0.0060 0.0105 0.1515)
+(-0.0060 0.0135 0.1515)
+(-0.0030 0.0135 0.1515)
+(0.0000 0.0135 0.1515)
+(0.0030 0.0135 0.1515)
+(0.0060 0.0135 0.1515)
+(-0.0060 0.0165 0.1515)
+(-0.0030 0.0165 0.1515)
+(0.0000 0.0165 0.1515)
+(0.0030 0.0165 0.1515)
+(0.0060 0.0165 0.1515)
+(-0.0060 0.0195 0.1515)
+(-0.0030 0.0195 0.1515)
+(0.0000 0.0195 0.1515)
+(0.0030 0.0195 0.1515)
+(0.0060 0.0195 0.1515)
+(-0.0060 0.0225 0.1515)
+(-0.0030 0.0225 0.1515)
+(0.0000 0.0225 0.1515)
+(0.0030 0.0225 0.1515)
+(0.0060 0.0225 0.1515)
+(-0.0060 0.0255 0.1515)
+(-0.0030 0.0255 0.1515)
+(0.0000 0.0255 0.1515)
+(0.0030 0.0255 0.1515)
+(0.0060 0.0255 0.1515)
+(-0.0060 0.0285 0.1515)
+(-0.0030 0.0285 0.1515)
+(0.0000 0.0285 0.1515)
+(0.0030 0.0285 0.1515)
+(0.0060 0.0285 0.1515)
+(-0.0060 0.0315 0.1515)
+(-0.0030 0.0315 0.1515)
+(0.0000 0.0315 0.1515)
+(0.0030 0.0315 0.1515)
+(0.0060 0.0315 0.1515)
+(-0.0060 0.0345 0.1515)
+(-0.0030 0.0345 0.1515)
+(0.0000 0.0345 0.1515)
+(0.0030 0.0345 0.1515)
+(0.0060 0.0345 0.1515)
+(-0.0060 0.0375 0.1515)
+(-0.0030 0.0375 0.1515)
+(0.0000 0.0375 0.1515)
+(0.0030 0.0375 0.1515)
+(0.0060 0.0375 0.1515)
+(-0.0060 0.0405 0.1515)
+(-0.0030 0.0405 0.1515)
+(0.0000 0.0405 0.1515)
+(0.0030 0.0405 0.1515)
+(0.0060 0.0405 0.1515)
+(-0.0060 0.0435 0.1515)
+(-0.0030 0.0435 0.1515)
+(0.0000 0.0435 0.1515)
+(0.0030 0.0435 0.1515)
+(0.0060 0.0435 0.1515)
+(-0.0060 0.0465 0.1515)
+(-0.0030 0.0465 0.1515)
+(0.0000 0.0465 0.1515)
+(0.0030 0.0465 0.1515)
+(0.0060 0.0465 0.1515)
+(-0.0060 0.0495 0.1515)
+(-0.0030 0.0495 0.1515)
+(0.0000 0.0495 0.1515)
+(0.0030 0.0495 0.1515)
+(0.0060 0.0495 0.1515)
+(-0.0060 0.0525 0.1515)
+(-0.0030 0.0525 0.1515)
+(0.0000 0.0525 0.1515)
+(0.0030 0.0525 0.1515)
+(0.0060 0.0525 0.1515)
+(-0.0060 0.0555 0.1515)
+(-0.0030 0.0555 0.1515)
+(0.0000 0.0555 0.1515)
+(0.0030 0.0555 0.1515)
+(0.0060 0.0555 0.1515)
+(-0.0060 0.0585 0.1515)
+(-0.0030 0.0585 0.1515)
+(0.0000 0.0585 0.1515)
+(0.0030 0.0585 0.1515)
+(0.0060 0.0585 0.1515)
+(-0.0060 0.0615 0.1515)
+(-0.0030 0.0615 0.1515)
+(0.0000 0.0615 0.1515)
+(0.0030 0.0615 0.1515)
+(0.0060 0.0615 0.1515)
+(-0.0060 0.0645 0.1515)
+(-0.0030 0.0645 0.1515)
+(0.0000 0.0645 0.1515)
+(0.0030 0.0645 0.1515)
+(0.0060 0.0645 0.1515)
+(-0.0060 0.0675 0.1515)
+(-0.0030 0.0675 0.1515)
+(0.0000 0.0675 0.1515)
+(0.0030 0.0675 0.1515)
+(0.0060 0.0675 0.1515)
+(-0.0060 0.0705 0.1515)
+(-0.0030 0.0705 0.1515)
+(0.0000 0.0705 0.1515)
+(0.0030 0.0705 0.1515)
+(0.0060 0.0705 0.1515)
+(-0.0060 0.0735 0.1515)
+(-0.0030 0.0735 0.1515)
+(0.0000 0.0735 0.1515)
+(0.0030 0.0735 0.1515)
+(0.0060 0.0735 0.1515)
+(-0.0060 -0.0735 0.1545)
+(-0.0030 -0.0735 0.1545)
+(0.0000 -0.0735 0.1545)
+(0.0030 -0.0735 0.1545)
+(0.0060 -0.0735 0.1545)
+(-0.0060 -0.0705 0.1545)
+(-0.0030 -0.0705 0.1545)
+(0.0000 -0.0705 0.1545)
+(0.0030 -0.0705 0.1545)
+(0.0060 -0.0705 0.1545)
+(-0.0060 -0.0675 0.1545)
+(-0.0030 -0.0675 0.1545)
+(0.0000 -0.0675 0.1545)
+(0.0030 -0.0675 0.1545)
+(0.0060 -0.0675 0.1545)
+(-0.0060 -0.0645 0.1545)
+(-0.0030 -0.0645 0.1545)
+(0.0000 -0.0645 0.1545)
+(0.0030 -0.0645 0.1545)
+(0.0060 -0.0645 0.1545)
+(-0.0060 -0.0615 0.1545)
+(-0.0030 -0.0615 0.1545)
+(0.0000 -0.0615 0.1545)
+(0.0030 -0.0615 0.1545)
+(0.0060 -0.0615 0.1545)
+(-0.0060 -0.0585 0.1545)
+(-0.0030 -0.0585 0.1545)
+(0.0000 -0.0585 0.1545)
+(0.0030 -0.0585 0.1545)
+(0.0060 -0.0585 0.1545)
+(-0.0060 -0.0555 0.1545)
+(-0.0030 -0.0555 0.1545)
+(0.0000 -0.0555 0.1545)
+(0.0030 -0.0555 0.1545)
+(0.0060 -0.0555 0.1545)
+(-0.0060 -0.0525 0.1545)
+(-0.0030 -0.0525 0.1545)
+(0.0000 -0.0525 0.1545)
+(0.0030 -0.0525 0.1545)
+(0.0060 -0.0525 0.1545)
+(-0.0060 -0.0495 0.1545)
+(-0.0030 -0.0495 0.1545)
+(0.0000 -0.0495 0.1545)
+(0.0030 -0.0495 0.1545)
+(0.0060 -0.0495 0.1545)
+(-0.0060 -0.0465 0.1545)
+(-0.0030 -0.0465 0.1545)
+(0.0000 -0.0465 0.1545)
+(0.0030 -0.0465 0.1545)
+(0.0060 -0.0465 0.1545)
+(-0.0060 -0.0435 0.1545)
+(-0.0030 -0.0435 0.1545)
+(0.0000 -0.0435 0.1545)
+(0.0030 -0.0435 0.1545)
+(0.0060 -0.0435 0.1545)
+(-0.0060 -0.0405 0.1545)
+(-0.0030 -0.0405 0.1545)
+(0.0000 -0.0405 0.1545)
+(0.0030 -0.0405 0.1545)
+(0.0060 -0.0405 0.1545)
+(-0.0060 -0.0375 0.1545)
+(-0.0030 -0.0375 0.1545)
+(0.0000 -0.0375 0.1545)
+(0.0030 -0.0375 0.1545)
+(0.0060 -0.0375 0.1545)
+(-0.0060 -0.0345 0.1545)
+(-0.0030 -0.0345 0.1545)
+(0.0000 -0.0345 0.1545)
+(0.0030 -0.0345 0.1545)
+(0.0060 -0.0345 0.1545)
+(-0.0060 -0.0315 0.1545)
+(-0.0030 -0.0315 0.1545)
+(0.0000 -0.0315 0.1545)
+(0.0030 -0.0315 0.1545)
+(0.0060 -0.0315 0.1545)
+(-0.0060 -0.0285 0.1545)
+(-0.0030 -0.0285 0.1545)
+(0.0000 -0.0285 0.1545)
+(0.0030 -0.0285 0.1545)
+(0.0060 -0.0285 0.1545)
+(-0.0060 -0.0255 0.1545)
+(-0.0030 -0.0255 0.1545)
+(0.0000 -0.0255 0.1545)
+(0.0030 -0.0255 0.1545)
+(0.0060 -0.0255 0.1545)
+(-0.0060 -0.0225 0.1545)
+(-0.0030 -0.0225 0.1545)
+(0.0000 -0.0225 0.1545)
+(0.0030 -0.0225 0.1545)
+(0.0060 -0.0225 0.1545)
+(-0.0060 -0.0195 0.1545)
+(-0.0030 -0.0195 0.1545)
+(0.0000 -0.0195 0.1545)
+(0.0030 -0.0195 0.1545)
+(0.0060 -0.0195 0.1545)
+(-0.0060 -0.0165 0.1545)
+(-0.0030 -0.0165 0.1545)
+(0.0000 -0.0165 0.1545)
+(0.0030 -0.0165 0.1545)
+(0.0060 -0.0165 0.1545)
+(-0.0060 -0.0135 0.1545)
+(-0.0030 -0.0135 0.1545)
+(0.0000 -0.0135 0.1545)
+(0.0030 -0.0135 0.1545)
+(0.0060 -0.0135 0.1545)
+(-0.0060 -0.0105 0.1545)
+(-0.0030 -0.0105 0.1545)
+(0.0000 -0.0105 0.1545)
+(0.0030 -0.0105 0.1545)
+(0.0060 -0.0105 0.1545)
+(-0.0060 -0.0075 0.1545)
+(-0.0030 -0.0075 0.1545)
+(0.0000 -0.0075 0.1545)
+(0.0030 -0.0075 0.1545)
+(0.0060 -0.0075 0.1545)
+(-0.0060 -0.0045 0.1545)
+(-0.0030 -0.0045 0.1545)
+(0.0000 -0.0045 0.1545)
+(0.0030 -0.0045 0.1545)
+(0.0060 -0.0045 0.1545)
+(-0.0060 -0.0015 0.1545)
+(-0.0030 -0.0015 0.1545)
+(0.0000 -0.0015 0.1545)
+(0.0030 -0.0015 0.1545)
+(0.0060 -0.0015 0.1545)
+(-0.0060 0.0015 0.1545)
+(-0.0030 0.0015 0.1545)
+(0.0000 0.0015 0.1545)
+(0.0030 0.0015 0.1545)
+(0.0060 0.0015 0.1545)
+(-0.0060 0.0045 0.1545)
+(-0.0030 0.0045 0.1545)
+(0.0000 0.0045 0.1545)
+(0.0030 0.0045 0.1545)
+(0.0060 0.0045 0.1545)
+(-0.0060 0.0075 0.1545)
+(-0.0030 0.0075 0.1545)
+(0.0000 0.0075 0.1545)
+(0.0030 0.0075 0.1545)
+(0.0060 0.0075 0.1545)
+(-0.0060 0.0105 0.1545)
+(-0.0030 0.0105 0.1545)
+(0.0000 0.0105 0.1545)
+(0.0030 0.0105 0.1545)
+(0.0060 0.0105 0.1545)
+(-0.0060 0.0135 0.1545)
+(-0.0030 0.0135 0.1545)
+(0.0000 0.0135 0.1545)
+(0.0030 0.0135 0.1545)
+(0.0060 0.0135 0.1545)
+(-0.0060 0.0165 0.1545)
+(-0.0030 0.0165 0.1545)
+(0.0000 0.0165 0.1545)
+(0.0030 0.0165 0.1545)
+(0.0060 0.0165 0.1545)
+(-0.0060 0.0195 0.1545)
+(-0.0030 0.0195 0.1545)
+(0.0000 0.0195 0.1545)
+(0.0030 0.0195 0.1545)
+(0.0060 0.0195 0.1545)
+(-0.0060 0.0225 0.1545)
+(-0.0030 0.0225 0.1545)
+(0.0000 0.0225 0.1545)
+(0.0030 0.0225 0.1545)
+(0.0060 0.0225 0.1545)
+(-0.0060 0.0255 0.1545)
+(-0.0030 0.0255 0.1545)
+(0.0000 0.0255 0.1545)
+(0.0030 0.0255 0.1545)
+(0.0060 0.0255 0.1545)
+(-0.0060 0.0285 0.1545)
+(-0.0030 0.0285 0.1545)
+(0.0000 0.0285 0.1545)
+(0.0030 0.0285 0.1545)
+(0.0060 0.0285 0.1545)
+(-0.0060 0.0315 0.1545)
+(-0.0030 0.0315 0.1545)
+(0.0000 0.0315 0.1545)
+(0.0030 0.0315 0.1545)
+(0.0060 0.0315 0.1545)
+(-0.0060 0.0345 0.1545)
+(-0.0030 0.0345 0.1545)
+(0.0000 0.0345 0.1545)
+(0.0030 0.0345 0.1545)
+(0.0060 0.0345 0.1545)
+(-0.0060 0.0375 0.1545)
+(-0.0030 0.0375 0.1545)
+(0.0000 0.0375 0.1545)
+(0.0030 0.0375 0.1545)
+(0.0060 0.0375 0.1545)
+(-0.0060 0.0405 0.1545)
+(-0.0030 0.0405 0.1545)
+(0.0000 0.0405 0.1545)
+(0.0030 0.0405 0.1545)
+(0.0060 0.0405 0.1545)
+(-0.0060 0.0435 0.1545)
+(-0.0030 0.0435 0.1545)
+(0.0000 0.0435 0.1545)
+(0.0030 0.0435 0.1545)
+(0.0060 0.0435 0.1545)
+(-0.0060 0.0465 0.1545)
+(-0.0030 0.0465 0.1545)
+(0.0000 0.0465 0.1545)
+(0.0030 0.0465 0.1545)
+(0.0060 0.0465 0.1545)
+(-0.0060 0.0495 0.1545)
+(-0.0030 0.0495 0.1545)
+(0.0000 0.0495 0.1545)
+(0.0030 0.0495 0.1545)
+(0.0060 0.0495 0.1545)
+(-0.0060 0.0525 0.1545)
+(-0.0030 0.0525 0.1545)
+(0.0000 0.0525 0.1545)
+(0.0030 0.0525 0.1545)
+(0.0060 0.0525 0.1545)
+(-0.0060 0.0555 0.1545)
+(-0.0030 0.0555 0.1545)
+(0.0000 0.0555 0.1545)
+(0.0030 0.0555 0.1545)
+(0.0060 0.0555 0.1545)
+(-0.0060 0.0585 0.1545)
+(-0.0030 0.0585 0.1545)
+(0.0000 0.0585 0.1545)
+(0.0030 0.0585 0.1545)
+(0.0060 0.0585 0.1545)
+(-0.0060 0.0615 0.1545)
+(-0.0030 0.0615 0.1545)
+(0.0000 0.0615 0.1545)
+(0.0030 0.0615 0.1545)
+(0.0060 0.0615 0.1545)
+(-0.0060 0.0645 0.1545)
+(-0.0030 0.0645 0.1545)
+(0.0000 0.0645 0.1545)
+(0.0030 0.0645 0.1545)
+(0.0060 0.0645 0.1545)
+(-0.0060 0.0675 0.1545)
+(-0.0030 0.0675 0.1545)
+(0.0000 0.0675 0.1545)
+(0.0030 0.0675 0.1545)
+(0.0060 0.0675 0.1545)
+(-0.0060 0.0705 0.1545)
+(-0.0030 0.0705 0.1545)
+(0.0000 0.0705 0.1545)
+(0.0030 0.0705 0.1545)
+(0.0060 0.0705 0.1545)
+(-0.0060 0.0735 0.1545)
+(-0.0030 0.0735 0.1545)
+(0.0000 0.0735 0.1545)
+(0.0030 0.0735 0.1545)
+(0.0060 0.0735 0.1545)
+(-0.0060 -0.0735 0.1575)
+(-0.0030 -0.0735 0.1575)
+(0.0000 -0.0735 0.1575)
+(0.0030 -0.0735 0.1575)
+(0.0060 -0.0735 0.1575)
+(-0.0060 -0.0705 0.1575)
+(-0.0030 -0.0705 0.1575)
+(0.0000 -0.0705 0.1575)
+(0.0030 -0.0705 0.1575)
+(0.0060 -0.0705 0.1575)
+(-0.0060 -0.0675 0.1575)
+(-0.0030 -0.0675 0.1575)
+(0.0000 -0.0675 0.1575)
+(0.0030 -0.0675 0.1575)
+(0.0060 -0.0675 0.1575)
+(-0.0060 -0.0645 0.1575)
+(-0.0030 -0.0645 0.1575)
+(0.0000 -0.0645 0.1575)
+(0.0030 -0.0645 0.1575)
+(0.0060 -0.0645 0.1575)
+(-0.0060 -0.0615 0.1575)
+(-0.0030 -0.0615 0.1575)
+(0.0000 -0.0615 0.1575)
+(0.0030 -0.0615 0.1575)
+(0.0060 -0.0615 0.1575)
+(-0.0060 -0.0585 0.1575)
+(-0.0030 -0.0585 0.1575)
+(0.0000 -0.0585 0.1575)
+(0.0030 -0.0585 0.1575)
+(0.0060 -0.0585 0.1575)
+(-0.0060 -0.0555 0.1575)
+(-0.0030 -0.0555 0.1575)
+(0.0000 -0.0555 0.1575)
+(0.0030 -0.0555 0.1575)
+(0.0060 -0.0555 0.1575)
+(-0.0060 -0.0525 0.1575)
+(-0.0030 -0.0525 0.1575)
+(0.0000 -0.0525 0.1575)
+(0.0030 -0.0525 0.1575)
+(0.0060 -0.0525 0.1575)
+(-0.0060 -0.0495 0.1575)
+(-0.0030 -0.0495 0.1575)
+(0.0000 -0.0495 0.1575)
+(0.0030 -0.0495 0.1575)
+(0.0060 -0.0495 0.1575)
+(-0.0060 -0.0465 0.1575)
+(-0.0030 -0.0465 0.1575)
+(0.0000 -0.0465 0.1575)
+(0.0030 -0.0465 0.1575)
+(0.0060 -0.0465 0.1575)
+(-0.0060 -0.0435 0.1575)
+(-0.0030 -0.0435 0.1575)
+(0.0000 -0.0435 0.1575)
+(0.0030 -0.0435 0.1575)
+(0.0060 -0.0435 0.1575)
+(-0.0060 -0.0405 0.1575)
+(-0.0030 -0.0405 0.1575)
+(0.0000 -0.0405 0.1575)
+(0.0030 -0.0405 0.1575)
+(0.0060 -0.0405 0.1575)
+(-0.0060 -0.0375 0.1575)
+(-0.0030 -0.0375 0.1575)
+(0.0000 -0.0375 0.1575)
+(0.0030 -0.0375 0.1575)
+(0.0060 -0.0375 0.1575)
+(-0.0060 -0.0345 0.1575)
+(-0.0030 -0.0345 0.1575)
+(0.0000 -0.0345 0.1575)
+(0.0030 -0.0345 0.1575)
+(0.0060 -0.0345 0.1575)
+(-0.0060 -0.0315 0.1575)
+(-0.0030 -0.0315 0.1575)
+(0.0000 -0.0315 0.1575)
+(0.0030 -0.0315 0.1575)
+(0.0060 -0.0315 0.1575)
+(-0.0060 -0.0285 0.1575)
+(-0.0030 -0.0285 0.1575)
+(0.0000 -0.0285 0.1575)
+(0.0030 -0.0285 0.1575)
+(0.0060 -0.0285 0.1575)
+(-0.0060 -0.0255 0.1575)
+(-0.0030 -0.0255 0.1575)
+(0.0000 -0.0255 0.1575)
+(0.0030 -0.0255 0.1575)
+(0.0060 -0.0255 0.1575)
+(-0.0060 -0.0225 0.1575)
+(-0.0030 -0.0225 0.1575)
+(0.0000 -0.0225 0.1575)
+(0.0030 -0.0225 0.1575)
+(0.0060 -0.0225 0.1575)
+(-0.0060 -0.0195 0.1575)
+(-0.0030 -0.0195 0.1575)
+(0.0000 -0.0195 0.1575)
+(0.0030 -0.0195 0.1575)
+(0.0060 -0.0195 0.1575)
+(-0.0060 -0.0165 0.1575)
+(-0.0030 -0.0165 0.1575)
+(0.0000 -0.0165 0.1575)
+(0.0030 -0.0165 0.1575)
+(0.0060 -0.0165 0.1575)
+(-0.0060 -0.0135 0.1575)
+(-0.0030 -0.0135 0.1575)
+(0.0000 -0.0135 0.1575)
+(0.0030 -0.0135 0.1575)
+(0.0060 -0.0135 0.1575)
+(-0.0060 -0.0105 0.1575)
+(-0.0030 -0.0105 0.1575)
+(0.0000 -0.0105 0.1575)
+(0.0030 -0.0105 0.1575)
+(0.0060 -0.0105 0.1575)
+(-0.0060 -0.0075 0.1575)
+(-0.0030 -0.0075 0.1575)
+(0.0000 -0.0075 0.1575)
+(0.0030 -0.0075 0.1575)
+(0.0060 -0.0075 0.1575)
+(-0.0060 -0.0045 0.1575)
+(-0.0030 -0.0045 0.1575)
+(0.0000 -0.0045 0.1575)
+(0.0030 -0.0045 0.1575)
+(0.0060 -0.0045 0.1575)
+(-0.0060 -0.0015 0.1575)
+(-0.0030 -0.0015 0.1575)
+(0.0000 -0.0015 0.1575)
+(0.0030 -0.0015 0.1575)
+(0.0060 -0.0015 0.1575)
+(-0.0060 0.0015 0.1575)
+(-0.0030 0.0015 0.1575)
+(0.0000 0.0015 0.1575)
+(0.0030 0.0015 0.1575)
+(0.0060 0.0015 0.1575)
+(-0.0060 0.0045 0.1575)
+(-0.0030 0.0045 0.1575)
+(0.0000 0.0045 0.1575)
+(0.0030 0.0045 0.1575)
+(0.0060 0.0045 0.1575)
+(-0.0060 0.0075 0.1575)
+(-0.0030 0.0075 0.1575)
+(0.0000 0.0075 0.1575)
+(0.0030 0.0075 0.1575)
+(0.0060 0.0075 0.1575)
+(-0.0060 0.0105 0.1575)
+(-0.0030 0.0105 0.1575)
+(0.0000 0.0105 0.1575)
+(0.0030 0.0105 0.1575)
+(0.0060 0.0105 0.1575)
+(-0.0060 0.0135 0.1575)
+(-0.0030 0.0135 0.1575)
+(0.0000 0.0135 0.1575)
+(0.0030 0.0135 0.1575)
+(0.0060 0.0135 0.1575)
+(-0.0060 0.0165 0.1575)
+(-0.0030 0.0165 0.1575)
+(0.0000 0.0165 0.1575)
+(0.0030 0.0165 0.1575)
+(0.0060 0.0165 0.1575)
+(-0.0060 0.0195 0.1575)
+(-0.0030 0.0195 0.1575)
+(0.0000 0.0195 0.1575)
+(0.0030 0.0195 0.1575)
+(0.0060 0.0195 0.1575)
+(-0.0060 0.0225 0.1575)
+(-0.0030 0.0225 0.1575)
+(0.0000 0.0225 0.1575)
+(0.0030 0.0225 0.1575)
+(0.0060 0.0225 0.1575)
+(-0.0060 0.0255 0.1575)
+(-0.0030 0.0255 0.1575)
+(0.0000 0.0255 0.1575)
+(0.0030 0.0255 0.1575)
+(0.0060 0.0255 0.1575)
+(-0.0060 0.0285 0.1575)
+(-0.0030 0.0285 0.1575)
+(0.0000 0.0285 0.1575)
+(0.0030 0.0285 0.1575)
+(0.0060 0.0285 0.1575)
+(-0.0060 0.0315 0.1575)
+(-0.0030 0.0315 0.1575)
+(0.0000 0.0315 0.1575)
+(0.0030 0.0315 0.1575)
+(0.0060 0.0315 0.1575)
+(-0.0060 0.0345 0.1575)
+(-0.0030 0.0345 0.1575)
+(0.0000 0.0345 0.1575)
+(0.0030 0.0345 0.1575)
+(0.0060 0.0345 0.1575)
+(-0.0060 0.0375 0.1575)
+(-0.0030 0.0375 0.1575)
+(0.0000 0.0375 0.1575)
+(0.0030 0.0375 0.1575)
+(0.0060 0.0375 0.1575)
+(-0.0060 0.0405 0.1575)
+(-0.0030 0.0405 0.1575)
+(0.0000 0.0405 0.1575)
+(0.0030 0.0405 0.1575)
+(0.0060 0.0405 0.1575)
+(-0.0060 0.0435 0.1575)
+(-0.0030 0.0435 0.1575)
+(0.0000 0.0435 0.1575)
+(0.0030 0.0435 0.1575)
+(0.0060 0.0435 0.1575)
+(-0.0060 0.0465 0.1575)
+(-0.0030 0.0465 0.1575)
+(0.0000 0.0465 0.1575)
+(0.0030 0.0465 0.1575)
+(0.0060 0.0465 0.1575)
+(-0.0060 0.0495 0.1575)
+(-0.0030 0.0495 0.1575)
+(0.0000 0.0495 0.1575)
+(0.0030 0.0495 0.1575)
+(0.0060 0.0495 0.1575)
+(-0.0060 0.0525 0.1575)
+(-0.0030 0.0525 0.1575)
+(0.0000 0.0525 0.1575)
+(0.0030 0.0525 0.1575)
+(0.0060 0.0525 0.1575)
+(-0.0060 0.0555 0.1575)
+(-0.0030 0.0555 0.1575)
+(0.0000 0.0555 0.1575)
+(0.0030 0.0555 0.1575)
+(0.0060 0.0555 0.1575)
+(-0.0060 0.0585 0.1575)
+(-0.0030 0.0585 0.1575)
+(0.0000 0.0585 0.1575)
+(0.0030 0.0585 0.1575)
+(0.0060 0.0585 0.1575)
+(-0.0060 0.0615 0.1575)
+(-0.0030 0.0615 0.1575)
+(0.0000 0.0615 0.1575)
+(0.0030 0.0615 0.1575)
+(0.0060 0.0615 0.1575)
+(-0.0060 0.0645 0.1575)
+(-0.0030 0.0645 0.1575)
+(0.0000 0.0645 0.1575)
+(0.0030 0.0645 0.1575)
+(0.0060 0.0645 0.1575)
+(-0.0060 0.0675 0.1575)
+(-0.0030 0.0675 0.1575)
+(0.0000 0.0675 0.1575)
+(0.0030 0.0675 0.1575)
+(0.0060 0.0675 0.1575)
+(-0.0060 0.0705 0.1575)
+(-0.0030 0.0705 0.1575)
+(0.0000 0.0705 0.1575)
+(0.0030 0.0705 0.1575)
+(0.0060 0.0705 0.1575)
+(-0.0060 0.0735 0.1575)
+(-0.0030 0.0735 0.1575)
+(0.0000 0.0735 0.1575)
+(0.0030 0.0735 0.1575)
+(0.0060 0.0735 0.1575)
+(-0.0060 -0.0735 0.1605)
+(-0.0030 -0.0735 0.1605)
+(0.0000 -0.0735 0.1605)
+(0.0030 -0.0735 0.1605)
+(0.0060 -0.0735 0.1605)
+(-0.0060 -0.0705 0.1605)
+(-0.0030 -0.0705 0.1605)
+(0.0000 -0.0705 0.1605)
+(0.0030 -0.0705 0.1605)
+(0.0060 -0.0705 0.1605)
+(-0.0060 -0.0675 0.1605)
+(-0.0030 -0.0675 0.1605)
+(0.0000 -0.0675 0.1605)
+(0.0030 -0.0675 0.1605)
+(0.0060 -0.0675 0.1605)
+(-0.0060 -0.0645 0.1605)
+(-0.0030 -0.0645 0.1605)
+(0.0000 -0.0645 0.1605)
+(0.0030 -0.0645 0.1605)
+(0.0060 -0.0645 0.1605)
+(-0.0060 -0.0615 0.1605)
+(-0.0030 -0.0615 0.1605)
+(0.0000 -0.0615 0.1605)
+(0.0030 -0.0615 0.1605)
+(0.0060 -0.0615 0.1605)
+(-0.0060 -0.0585 0.1605)
+(-0.0030 -0.0585 0.1605)
+(0.0000 -0.0585 0.1605)
+(0.0030 -0.0585 0.1605)
+(0.0060 -0.0585 0.1605)
+(-0.0060 -0.0555 0.1605)
+(-0.0030 -0.0555 0.1605)
+(0.0000 -0.0555 0.1605)
+(0.0030 -0.0555 0.1605)
+(0.0060 -0.0555 0.1605)
+(-0.0060 -0.0525 0.1605)
+(-0.0030 -0.0525 0.1605)
+(0.0000 -0.0525 0.1605)
+(0.0030 -0.0525 0.1605)
+(0.0060 -0.0525 0.1605)
+(-0.0060 -0.0495 0.1605)
+(-0.0030 -0.0495 0.1605)
+(0.0000 -0.0495 0.1605)
+(0.0030 -0.0495 0.1605)
+(0.0060 -0.0495 0.1605)
+(-0.0060 -0.0465 0.1605)
+(-0.0030 -0.0465 0.1605)
+(0.0000 -0.0465 0.1605)
+(0.0030 -0.0465 0.1605)
+(0.0060 -0.0465 0.1605)
+(-0.0060 -0.0435 0.1605)
+(-0.0030 -0.0435 0.1605)
+(0.0000 -0.0435 0.1605)
+(0.0030 -0.0435 0.1605)
+(0.0060 -0.0435 0.1605)
+(-0.0060 -0.0405 0.1605)
+(-0.0030 -0.0405 0.1605)
+(0.0000 -0.0405 0.1605)
+(0.0030 -0.0405 0.1605)
+(0.0060 -0.0405 0.1605)
+(-0.0060 -0.0375 0.1605)
+(-0.0030 -0.0375 0.1605)
+(0.0000 -0.0375 0.1605)
+(0.0030 -0.0375 0.1605)
+(0.0060 -0.0375 0.1605)
+(-0.0060 -0.0345 0.1605)
+(-0.0030 -0.0345 0.1605)
+(0.0000 -0.0345 0.1605)
+(0.0030 -0.0345 0.1605)
+(0.0060 -0.0345 0.1605)
+(-0.0060 -0.0315 0.1605)
+(-0.0030 -0.0315 0.1605)
+(0.0000 -0.0315 0.1605)
+(0.0030 -0.0315 0.1605)
+(0.0060 -0.0315 0.1605)
+(-0.0060 -0.0285 0.1605)
+(-0.0030 -0.0285 0.1605)
+(0.0000 -0.0285 0.1605)
+(0.0030 -0.0285 0.1605)
+(0.0060 -0.0285 0.1605)
+(-0.0060 -0.0255 0.1605)
+(-0.0030 -0.0255 0.1605)
+(0.0000 -0.0255 0.1605)
+(0.0030 -0.0255 0.1605)
+(0.0060 -0.0255 0.1605)
+(-0.0060 -0.0225 0.1605)
+(-0.0030 -0.0225 0.1605)
+(0.0000 -0.0225 0.1605)
+(0.0030 -0.0225 0.1605)
+(0.0060 -0.0225 0.1605)
+(-0.0060 -0.0195 0.1605)
+(-0.0030 -0.0195 0.1605)
+(0.0000 -0.0195 0.1605)
+(0.0030 -0.0195 0.1605)
+(0.0060 -0.0195 0.1605)
+(-0.0060 -0.0165 0.1605)
+(-0.0030 -0.0165 0.1605)
+(0.0000 -0.0165 0.1605)
+(0.0030 -0.0165 0.1605)
+(0.0060 -0.0165 0.1605)
+(-0.0060 -0.0135 0.1605)
+(-0.0030 -0.0135 0.1605)
+(0.0000 -0.0135 0.1605)
+(0.0030 -0.0135 0.1605)
+(0.0060 -0.0135 0.1605)
+(-0.0060 -0.0105 0.1605)
+(-0.0030 -0.0105 0.1605)
+(0.0000 -0.0105 0.1605)
+(0.0030 -0.0105 0.1605)
+(0.0060 -0.0105 0.1605)
+(-0.0060 -0.0075 0.1605)
+(-0.0030 -0.0075 0.1605)
+(0.0000 -0.0075 0.1605)
+(0.0030 -0.0075 0.1605)
+(0.0060 -0.0075 0.1605)
+(-0.0060 -0.0045 0.1605)
+(-0.0030 -0.0045 0.1605)
+(0.0000 -0.0045 0.1605)
+(0.0030 -0.0045 0.1605)
+(0.0060 -0.0045 0.1605)
+(-0.0060 -0.0015 0.1605)
+(-0.0030 -0.0015 0.1605)
+(0.0000 -0.0015 0.1605)
+(0.0030 -0.0015 0.1605)
+(0.0060 -0.0015 0.1605)
+(-0.0060 0.0015 0.1605)
+(-0.0030 0.0015 0.1605)
+(0.0000 0.0015 0.1605)
+(0.0030 0.0015 0.1605)
+(0.0060 0.0015 0.1605)
+(-0.0060 0.0045 0.1605)
+(-0.0030 0.0045 0.1605)
+(0.0000 0.0045 0.1605)
+(0.0030 0.0045 0.1605)
+(0.0060 0.0045 0.1605)
+(-0.0060 0.0075 0.1605)
+(-0.0030 0.0075 0.1605)
+(0.0000 0.0075 0.1605)
+(0.0030 0.0075 0.1605)
+(0.0060 0.0075 0.1605)
+(-0.0060 0.0105 0.1605)
+(-0.0030 0.0105 0.1605)
+(0.0000 0.0105 0.1605)
+(0.0030 0.0105 0.1605)
+(0.0060 0.0105 0.1605)
+(-0.0060 0.0135 0.1605)
+(-0.0030 0.0135 0.1605)
+(0.0000 0.0135 0.1605)
+(0.0030 0.0135 0.1605)
+(0.0060 0.0135 0.1605)
+(-0.0060 0.0165 0.1605)
+(-0.0030 0.0165 0.1605)
+(0.0000 0.0165 0.1605)
+(0.0030 0.0165 0.1605)
+(0.0060 0.0165 0.1605)
+(-0.0060 0.0195 0.1605)
+(-0.0030 0.0195 0.1605)
+(0.0000 0.0195 0.1605)
+(0.0030 0.0195 0.1605)
+(0.0060 0.0195 0.1605)
+(-0.0060 0.0225 0.1605)
+(-0.0030 0.0225 0.1605)
+(0.0000 0.0225 0.1605)
+(0.0030 0.0225 0.1605)
+(0.0060 0.0225 0.1605)
+(-0.0060 0.0255 0.1605)
+(-0.0030 0.0255 0.1605)
+(0.0000 0.0255 0.1605)
+(0.0030 0.0255 0.1605)
+(0.0060 0.0255 0.1605)
+(-0.0060 0.0285 0.1605)
+(-0.0030 0.0285 0.1605)
+(0.0000 0.0285 0.1605)
+(0.0030 0.0285 0.1605)
+(0.0060 0.0285 0.1605)
+(-0.0060 0.0315 0.1605)
+(-0.0030 0.0315 0.1605)
+(0.0000 0.0315 0.1605)
+(0.0030 0.0315 0.1605)
+(0.0060 0.0315 0.1605)
+(-0.0060 0.0345 0.1605)
+(-0.0030 0.0345 0.1605)
+(0.0000 0.0345 0.1605)
+(0.0030 0.0345 0.1605)
+(0.0060 0.0345 0.1605)
+(-0.0060 0.0375 0.1605)
+(-0.0030 0.0375 0.1605)
+(0.0000 0.0375 0.1605)
+(0.0030 0.0375 0.1605)
+(0.0060 0.0375 0.1605)
+(-0.0060 0.0405 0.1605)
+(-0.0030 0.0405 0.1605)
+(0.0000 0.0405 0.1605)
+(0.0030 0.0405 0.1605)
+(0.0060 0.0405 0.1605)
+(-0.0060 0.0435 0.1605)
+(-0.0030 0.0435 0.1605)
+(0.0000 0.0435 0.1605)
+(0.0030 0.0435 0.1605)
+(0.0060 0.0435 0.1605)
+(-0.0060 0.0465 0.1605)
+(-0.0030 0.0465 0.1605)
+(0.0000 0.0465 0.1605)
+(0.0030 0.0465 0.1605)
+(0.0060 0.0465 0.1605)
+(-0.0060 0.0495 0.1605)
+(-0.0030 0.0495 0.1605)
+(0.0000 0.0495 0.1605)
+(0.0030 0.0495 0.1605)
+(0.0060 0.0495 0.1605)
+(-0.0060 0.0525 0.1605)
+(-0.0030 0.0525 0.1605)
+(0.0000 0.0525 0.1605)
+(0.0030 0.0525 0.1605)
+(0.0060 0.0525 0.1605)
+(-0.0060 0.0555 0.1605)
+(-0.0030 0.0555 0.1605)
+(0.0000 0.0555 0.1605)
+(0.0030 0.0555 0.1605)
+(0.0060 0.0555 0.1605)
+(-0.0060 0.0585 0.1605)
+(-0.0030 0.0585 0.1605)
+(0.0000 0.0585 0.1605)
+(0.0030 0.0585 0.1605)
+(0.0060 0.0585 0.1605)
+(-0.0060 0.0615 0.1605)
+(-0.0030 0.0615 0.1605)
+(0.0000 0.0615 0.1605)
+(0.0030 0.0615 0.1605)
+(0.0060 0.0615 0.1605)
+(-0.0060 0.0645 0.1605)
+(-0.0030 0.0645 0.1605)
+(0.0000 0.0645 0.1605)
+(0.0030 0.0645 0.1605)
+(0.0060 0.0645 0.1605)
+(-0.0060 0.0675 0.1605)
+(-0.0030 0.0675 0.1605)
+(0.0000 0.0675 0.1605)
+(0.0030 0.0675 0.1605)
+(0.0060 0.0675 0.1605)
+(-0.0060 0.0705 0.1605)
+(-0.0030 0.0705 0.1605)
+(0.0000 0.0705 0.1605)
+(0.0030 0.0705 0.1605)
+(0.0060 0.0705 0.1605)
+(-0.0060 0.0735 0.1605)
+(-0.0030 0.0735 0.1605)
+(0.0000 0.0735 0.1605)
+(0.0030 0.0735 0.1605)
+(0.0060 0.0735 0.1605)
+(-0.0060 -0.0735 0.1635)
+(-0.0030 -0.0735 0.1635)
+(0.0000 -0.0735 0.1635)
+(0.0030 -0.0735 0.1635)
+(0.0060 -0.0735 0.1635)
+(-0.0060 -0.0705 0.1635)
+(-0.0030 -0.0705 0.1635)
+(0.0000 -0.0705 0.1635)
+(0.0030 -0.0705 0.1635)
+(0.0060 -0.0705 0.1635)
+(-0.0060 -0.0675 0.1635)
+(-0.0030 -0.0675 0.1635)
+(0.0000 -0.0675 0.1635)
+(0.0030 -0.0675 0.1635)
+(0.0060 -0.0675 0.1635)
+(-0.0060 -0.0645 0.1635)
+(-0.0030 -0.0645 0.1635)
+(0.0000 -0.0645 0.1635)
+(0.0030 -0.0645 0.1635)
+(0.0060 -0.0645 0.1635)
+(-0.0060 -0.0615 0.1635)
+(-0.0030 -0.0615 0.1635)
+(0.0000 -0.0615 0.1635)
+(0.0030 -0.0615 0.1635)
+(0.0060 -0.0615 0.1635)
+(-0.0060 -0.0585 0.1635)
+(-0.0030 -0.0585 0.1635)
+(0.0000 -0.0585 0.1635)
+(0.0030 -0.0585 0.1635)
+(0.0060 -0.0585 0.1635)
+(-0.0060 -0.0555 0.1635)
+(-0.0030 -0.0555 0.1635)
+(0.0000 -0.0555 0.1635)
+(0.0030 -0.0555 0.1635)
+(0.0060 -0.0555 0.1635)
+(-0.0060 -0.0525 0.1635)
+(-0.0030 -0.0525 0.1635)
+(0.0000 -0.0525 0.1635)
+(0.0030 -0.0525 0.1635)
+(0.0060 -0.0525 0.1635)
+(-0.0060 -0.0495 0.1635)
+(-0.0030 -0.0495 0.1635)
+(0.0000 -0.0495 0.1635)
+(0.0030 -0.0495 0.1635)
+(0.0060 -0.0495 0.1635)
+(-0.0060 -0.0465 0.1635)
+(-0.0030 -0.0465 0.1635)
+(0.0000 -0.0465 0.1635)
+(0.0030 -0.0465 0.1635)
+(0.0060 -0.0465 0.1635)
+(-0.0060 -0.0435 0.1635)
+(-0.0030 -0.0435 0.1635)
+(0.0000 -0.0435 0.1635)
+(0.0030 -0.0435 0.1635)
+(0.0060 -0.0435 0.1635)
+(-0.0060 -0.0405 0.1635)
+(-0.0030 -0.0405 0.1635)
+(0.0000 -0.0405 0.1635)
+(0.0030 -0.0405 0.1635)
+(0.0060 -0.0405 0.1635)
+(-0.0060 -0.0375 0.1635)
+(-0.0030 -0.0375 0.1635)
+(0.0000 -0.0375 0.1635)
+(0.0030 -0.0375 0.1635)
+(0.0060 -0.0375 0.1635)
+(-0.0060 -0.0345 0.1635)
+(-0.0030 -0.0345 0.1635)
+(0.0000 -0.0345 0.1635)
+(0.0030 -0.0345 0.1635)
+(0.0060 -0.0345 0.1635)
+(-0.0060 -0.0315 0.1635)
+(-0.0030 -0.0315 0.1635)
+(0.0000 -0.0315 0.1635)
+(0.0030 -0.0315 0.1635)
+(0.0060 -0.0315 0.1635)
+(-0.0060 -0.0285 0.1635)
+(-0.0030 -0.0285 0.1635)
+(0.0000 -0.0285 0.1635)
+(0.0030 -0.0285 0.1635)
+(0.0060 -0.0285 0.1635)
+(-0.0060 -0.0255 0.1635)
+(-0.0030 -0.0255 0.1635)
+(0.0000 -0.0255 0.1635)
+(0.0030 -0.0255 0.1635)
+(0.0060 -0.0255 0.1635)
+(-0.0060 -0.0225 0.1635)
+(-0.0030 -0.0225 0.1635)
+(0.0000 -0.0225 0.1635)
+(0.0030 -0.0225 0.1635)
+(0.0060 -0.0225 0.1635)
+(-0.0060 -0.0195 0.1635)
+(-0.0030 -0.0195 0.1635)
+(0.0000 -0.0195 0.1635)
+(0.0030 -0.0195 0.1635)
+(0.0060 -0.0195 0.1635)
+(-0.0060 -0.0165 0.1635)
+(-0.0030 -0.0165 0.1635)
+(0.0000 -0.0165 0.1635)
+(0.0030 -0.0165 0.1635)
+(0.0060 -0.0165 0.1635)
+(-0.0060 -0.0135 0.1635)
+(-0.0030 -0.0135 0.1635)
+(0.0000 -0.0135 0.1635)
+(0.0030 -0.0135 0.1635)
+(0.0060 -0.0135 0.1635)
+(-0.0060 -0.0105 0.1635)
+(-0.0030 -0.0105 0.1635)
+(0.0000 -0.0105 0.1635)
+(0.0030 -0.0105 0.1635)
+(0.0060 -0.0105 0.1635)
+(-0.0060 -0.0075 0.1635)
+(-0.0030 -0.0075 0.1635)
+(0.0000 -0.0075 0.1635)
+(0.0030 -0.0075 0.1635)
+(0.0060 -0.0075 0.1635)
+(-0.0060 -0.0045 0.1635)
+(-0.0030 -0.0045 0.1635)
+(0.0000 -0.0045 0.1635)
+(0.0030 -0.0045 0.1635)
+(0.0060 -0.0045 0.1635)
+(-0.0060 -0.0015 0.1635)
+(-0.0030 -0.0015 0.1635)
+(0.0000 -0.0015 0.1635)
+(0.0030 -0.0015 0.1635)
+(0.0060 -0.0015 0.1635)
+(-0.0060 0.0015 0.1635)
+(-0.0030 0.0015 0.1635)
+(0.0000 0.0015 0.1635)
+(0.0030 0.0015 0.1635)
+(0.0060 0.0015 0.1635)
+(-0.0060 0.0045 0.1635)
+(-0.0030 0.0045 0.1635)
+(0.0000 0.0045 0.1635)
+(0.0030 0.0045 0.1635)
+(0.0060 0.0045 0.1635)
+(-0.0060 0.0075 0.1635)
+(-0.0030 0.0075 0.1635)
+(0.0000 0.0075 0.1635)
+(0.0030 0.0075 0.1635)
+(0.0060 0.0075 0.1635)
+(-0.0060 0.0105 0.1635)
+(-0.0030 0.0105 0.1635)
+(0.0000 0.0105 0.1635)
+(0.0030 0.0105 0.1635)
+(0.0060 0.0105 0.1635)
+(-0.0060 0.0135 0.1635)
+(-0.0030 0.0135 0.1635)
+(0.0000 0.0135 0.1635)
+(0.0030 0.0135 0.1635)
+(0.0060 0.0135 0.1635)
+(-0.0060 0.0165 0.1635)
+(-0.0030 0.0165 0.1635)
+(0.0000 0.0165 0.1635)
+(0.0030 0.0165 0.1635)
+(0.0060 0.0165 0.1635)
+(-0.0060 0.0195 0.1635)
+(-0.0030 0.0195 0.1635)
+(0.0000 0.0195 0.1635)
+(0.0030 0.0195 0.1635)
+(0.0060 0.0195 0.1635)
+(-0.0060 0.0225 0.1635)
+(-0.0030 0.0225 0.1635)
+(0.0000 0.0225 0.1635)
+(0.0030 0.0225 0.1635)
+(0.0060 0.0225 0.1635)
+(-0.0060 0.0255 0.1635)
+(-0.0030 0.0255 0.1635)
+(0.0000 0.0255 0.1635)
+(0.0030 0.0255 0.1635)
+(0.0060 0.0255 0.1635)
+(-0.0060 0.0285 0.1635)
+(-0.0030 0.0285 0.1635)
+(0.0000 0.0285 0.1635)
+(0.0030 0.0285 0.1635)
+(0.0060 0.0285 0.1635)
+(-0.0060 0.0315 0.1635)
+(-0.0030 0.0315 0.1635)
+(0.0000 0.0315 0.1635)
+(0.0030 0.0315 0.1635)
+(0.0060 0.0315 0.1635)
+(-0.0060 0.0345 0.1635)
+(-0.0030 0.0345 0.1635)
+(0.0000 0.0345 0.1635)
+(0.0030 0.0345 0.1635)
+(0.0060 0.0345 0.1635)
+(-0.0060 0.0375 0.1635)
+(-0.0030 0.0375 0.1635)
+(0.0000 0.0375 0.1635)
+(0.0030 0.0375 0.1635)
+(0.0060 0.0375 0.1635)
+(-0.0060 0.0405 0.1635)
+(-0.0030 0.0405 0.1635)
+(0.0000 0.0405 0.1635)
+(0.0030 0.0405 0.1635)
+(0.0060 0.0405 0.1635)
+(-0.0060 0.0435 0.1635)
+(-0.0030 0.0435 0.1635)
+(0.0000 0.0435 0.1635)
+(0.0030 0.0435 0.1635)
+(0.0060 0.0435 0.1635)
+(-0.0060 0.0465 0.1635)
+(-0.0030 0.0465 0.1635)
+(0.0000 0.0465 0.1635)
+(0.0030 0.0465 0.1635)
+(0.0060 0.0465 0.1635)
+(-0.0060 0.0495 0.1635)
+(-0.0030 0.0495 0.1635)
+(0.0000 0.0495 0.1635)
+(0.0030 0.0495 0.1635)
+(0.0060 0.0495 0.1635)
+(-0.0060 0.0525 0.1635)
+(-0.0030 0.0525 0.1635)
+(0.0000 0.0525 0.1635)
+(0.0030 0.0525 0.1635)
+(0.0060 0.0525 0.1635)
+(-0.0060 0.0555 0.1635)
+(-0.0030 0.0555 0.1635)
+(0.0000 0.0555 0.1635)
+(0.0030 0.0555 0.1635)
+(0.0060 0.0555 0.1635)
+(-0.0060 0.0585 0.1635)
+(-0.0030 0.0585 0.1635)
+(0.0000 0.0585 0.1635)
+(0.0030 0.0585 0.1635)
+(0.0060 0.0585 0.1635)
+(-0.0060 0.0615 0.1635)
+(-0.0030 0.0615 0.1635)
+(0.0000 0.0615 0.1635)
+(0.0030 0.0615 0.1635)
+(0.0060 0.0615 0.1635)
+(-0.0060 0.0645 0.1635)
+(-0.0030 0.0645 0.1635)
+(0.0000 0.0645 0.1635)
+(0.0030 0.0645 0.1635)
+(0.0060 0.0645 0.1635)
+(-0.0060 0.0675 0.1635)
+(-0.0030 0.0675 0.1635)
+(0.0000 0.0675 0.1635)
+(0.0030 0.0675 0.1635)
+(0.0060 0.0675 0.1635)
+(-0.0060 0.0705 0.1635)
+(-0.0030 0.0705 0.1635)
+(0.0000 0.0705 0.1635)
+(0.0030 0.0705 0.1635)
+(0.0060 0.0705 0.1635)
+(-0.0060 0.0735 0.1635)
+(-0.0030 0.0735 0.1635)
+(0.0000 0.0735 0.1635)
+(0.0030 0.0735 0.1635)
+(0.0060 0.0735 0.1635)
+(-0.0060 -0.0735 0.1665)
+(-0.0030 -0.0735 0.1665)
+(0.0000 -0.0735 0.1665)
+(0.0030 -0.0735 0.1665)
+(0.0060 -0.0735 0.1665)
+(-0.0060 -0.0705 0.1665)
+(-0.0030 -0.0705 0.1665)
+(0.0000 -0.0705 0.1665)
+(0.0030 -0.0705 0.1665)
+(0.0060 -0.0705 0.1665)
+(-0.0060 -0.0675 0.1665)
+(-0.0030 -0.0675 0.1665)
+(0.0000 -0.0675 0.1665)
+(0.0030 -0.0675 0.1665)
+(0.0060 -0.0675 0.1665)
+(-0.0060 -0.0645 0.1665)
+(-0.0030 -0.0645 0.1665)
+(0.0000 -0.0645 0.1665)
+(0.0030 -0.0645 0.1665)
+(0.0060 -0.0645 0.1665)
+(-0.0060 -0.0615 0.1665)
+(-0.0030 -0.0615 0.1665)
+(0.0000 -0.0615 0.1665)
+(0.0030 -0.0615 0.1665)
+(0.0060 -0.0615 0.1665)
+(-0.0060 -0.0585 0.1665)
+(-0.0030 -0.0585 0.1665)
+(0.0000 -0.0585 0.1665)
+(0.0030 -0.0585 0.1665)
+(0.0060 -0.0585 0.1665)
+(-0.0060 -0.0555 0.1665)
+(-0.0030 -0.0555 0.1665)
+(0.0000 -0.0555 0.1665)
+(0.0030 -0.0555 0.1665)
+(0.0060 -0.0555 0.1665)
+(-0.0060 -0.0525 0.1665)
+(-0.0030 -0.0525 0.1665)
+(0.0000 -0.0525 0.1665)
+(0.0030 -0.0525 0.1665)
+(0.0060 -0.0525 0.1665)
+(-0.0060 -0.0495 0.1665)
+(-0.0030 -0.0495 0.1665)
+(0.0000 -0.0495 0.1665)
+(0.0030 -0.0495 0.1665)
+(0.0060 -0.0495 0.1665)
+(-0.0060 -0.0465 0.1665)
+(-0.0030 -0.0465 0.1665)
+(0.0000 -0.0465 0.1665)
+(0.0030 -0.0465 0.1665)
+(0.0060 -0.0465 0.1665)
+(-0.0060 -0.0435 0.1665)
+(-0.0030 -0.0435 0.1665)
+(0.0000 -0.0435 0.1665)
+(0.0030 -0.0435 0.1665)
+(0.0060 -0.0435 0.1665)
+(-0.0060 -0.0405 0.1665)
+(-0.0030 -0.0405 0.1665)
+(0.0000 -0.0405 0.1665)
+(0.0030 -0.0405 0.1665)
+(0.0060 -0.0405 0.1665)
+(-0.0060 -0.0375 0.1665)
+(-0.0030 -0.0375 0.1665)
+(0.0000 -0.0375 0.1665)
+(0.0030 -0.0375 0.1665)
+(0.0060 -0.0375 0.1665)
+(-0.0060 -0.0345 0.1665)
+(-0.0030 -0.0345 0.1665)
+(0.0000 -0.0345 0.1665)
+(0.0030 -0.0345 0.1665)
+(0.0060 -0.0345 0.1665)
+(-0.0060 -0.0315 0.1665)
+(-0.0030 -0.0315 0.1665)
+(0.0000 -0.0315 0.1665)
+(0.0030 -0.0315 0.1665)
+(0.0060 -0.0315 0.1665)
+(-0.0060 -0.0285 0.1665)
+(-0.0030 -0.0285 0.1665)
+(0.0000 -0.0285 0.1665)
+(0.0030 -0.0285 0.1665)
+(0.0060 -0.0285 0.1665)
+(-0.0060 -0.0255 0.1665)
+(-0.0030 -0.0255 0.1665)
+(0.0000 -0.0255 0.1665)
+(0.0030 -0.0255 0.1665)
+(0.0060 -0.0255 0.1665)
+(-0.0060 -0.0225 0.1665)
+(-0.0030 -0.0225 0.1665)
+(0.0000 -0.0225 0.1665)
+(0.0030 -0.0225 0.1665)
+(0.0060 -0.0225 0.1665)
+(-0.0060 -0.0195 0.1665)
+(-0.0030 -0.0195 0.1665)
+(0.0000 -0.0195 0.1665)
+(0.0030 -0.0195 0.1665)
+(0.0060 -0.0195 0.1665)
+(-0.0060 -0.0165 0.1665)
+(-0.0030 -0.0165 0.1665)
+(0.0000 -0.0165 0.1665)
+(0.0030 -0.0165 0.1665)
+(0.0060 -0.0165 0.1665)
+(-0.0060 -0.0135 0.1665)
+(-0.0030 -0.0135 0.1665)
+(0.0000 -0.0135 0.1665)
+(0.0030 -0.0135 0.1665)
+(0.0060 -0.0135 0.1665)
+(-0.0060 -0.0105 0.1665)
+(-0.0030 -0.0105 0.1665)
+(0.0000 -0.0105 0.1665)
+(0.0030 -0.0105 0.1665)
+(0.0060 -0.0105 0.1665)
+(-0.0060 -0.0075 0.1665)
+(-0.0030 -0.0075 0.1665)
+(0.0000 -0.0075 0.1665)
+(0.0030 -0.0075 0.1665)
+(0.0060 -0.0075 0.1665)
+(-0.0060 -0.0045 0.1665)
+(-0.0030 -0.0045 0.1665)
+(0.0000 -0.0045 0.1665)
+(0.0030 -0.0045 0.1665)
+(0.0060 -0.0045 0.1665)
+(-0.0060 -0.0015 0.1665)
+(-0.0030 -0.0015 0.1665)
+(0.0000 -0.0015 0.1665)
+(0.0030 -0.0015 0.1665)
+(0.0060 -0.0015 0.1665)
+(-0.0060 0.0015 0.1665)
+(-0.0030 0.0015 0.1665)
+(0.0000 0.0015 0.1665)
+(0.0030 0.0015 0.1665)
+(0.0060 0.0015 0.1665)
+(-0.0060 0.0045 0.1665)
+(-0.0030 0.0045 0.1665)
+(0.0000 0.0045 0.1665)
+(0.0030 0.0045 0.1665)
+(0.0060 0.0045 0.1665)
+(-0.0060 0.0075 0.1665)
+(-0.0030 0.0075 0.1665)
+(0.0000 0.0075 0.1665)
+(0.0030 0.0075 0.1665)
+(0.0060 0.0075 0.1665)
+(-0.0060 0.0105 0.1665)
+(-0.0030 0.0105 0.1665)
+(0.0000 0.0105 0.1665)
+(0.0030 0.0105 0.1665)
+(0.0060 0.0105 0.1665)
+(-0.0060 0.0135 0.1665)
+(-0.0030 0.0135 0.1665)
+(0.0000 0.0135 0.1665)
+(0.0030 0.0135 0.1665)
+(0.0060 0.0135 0.1665)
+(-0.0060 0.0165 0.1665)
+(-0.0030 0.0165 0.1665)
+(0.0000 0.0165 0.1665)
+(0.0030 0.0165 0.1665)
+(0.0060 0.0165 0.1665)
+(-0.0060 0.0195 0.1665)
+(-0.0030 0.0195 0.1665)
+(0.0000 0.0195 0.1665)
+(0.0030 0.0195 0.1665)
+(0.0060 0.0195 0.1665)
+(-0.0060 0.0225 0.1665)
+(-0.0030 0.0225 0.1665)
+(0.0000 0.0225 0.1665)
+(0.0030 0.0225 0.1665)
+(0.0060 0.0225 0.1665)
+(-0.0060 0.0255 0.1665)
+(-0.0030 0.0255 0.1665)
+(0.0000 0.0255 0.1665)
+(0.0030 0.0255 0.1665)
+(0.0060 0.0255 0.1665)
+(-0.0060 0.0285 0.1665)
+(-0.0030 0.0285 0.1665)
+(0.0000 0.0285 0.1665)
+(0.0030 0.0285 0.1665)
+(0.0060 0.0285 0.1665)
+(-0.0060 0.0315 0.1665)
+(-0.0030 0.0315 0.1665)
+(0.0000 0.0315 0.1665)
+(0.0030 0.0315 0.1665)
+(0.0060 0.0315 0.1665)
+(-0.0060 0.0345 0.1665)
+(-0.0030 0.0345 0.1665)
+(0.0000 0.0345 0.1665)
+(0.0030 0.0345 0.1665)
+(0.0060 0.0345 0.1665)
+(-0.0060 0.0375 0.1665)
+(-0.0030 0.0375 0.1665)
+(0.0000 0.0375 0.1665)
+(0.0030 0.0375 0.1665)
+(0.0060 0.0375 0.1665)
+(-0.0060 0.0405 0.1665)
+(-0.0030 0.0405 0.1665)
+(0.0000 0.0405 0.1665)
+(0.0030 0.0405 0.1665)
+(0.0060 0.0405 0.1665)
+(-0.0060 0.0435 0.1665)
+(-0.0030 0.0435 0.1665)
+(0.0000 0.0435 0.1665)
+(0.0030 0.0435 0.1665)
+(0.0060 0.0435 0.1665)
+(-0.0060 0.0465 0.1665)
+(-0.0030 0.0465 0.1665)
+(0.0000 0.0465 0.1665)
+(0.0030 0.0465 0.1665)
+(0.0060 0.0465 0.1665)
+(-0.0060 0.0495 0.1665)
+(-0.0030 0.0495 0.1665)
+(0.0000 0.0495 0.1665)
+(0.0030 0.0495 0.1665)
+(0.0060 0.0495 0.1665)
+(-0.0060 0.0525 0.1665)
+(-0.0030 0.0525 0.1665)
+(0.0000 0.0525 0.1665)
+(0.0030 0.0525 0.1665)
+(0.0060 0.0525 0.1665)
+(-0.0060 0.0555 0.1665)
+(-0.0030 0.0555 0.1665)
+(0.0000 0.0555 0.1665)
+(0.0030 0.0555 0.1665)
+(0.0060 0.0555 0.1665)
+(-0.0060 0.0585 0.1665)
+(-0.0030 0.0585 0.1665)
+(0.0000 0.0585 0.1665)
+(0.0030 0.0585 0.1665)
+(0.0060 0.0585 0.1665)
+(-0.0060 0.0615 0.1665)
+(-0.0030 0.0615 0.1665)
+(0.0000 0.0615 0.1665)
+(0.0030 0.0615 0.1665)
+(0.0060 0.0615 0.1665)
+(-0.0060 0.0645 0.1665)
+(-0.0030 0.0645 0.1665)
+(0.0000 0.0645 0.1665)
+(0.0030 0.0645 0.1665)
+(0.0060 0.0645 0.1665)
+(-0.0060 0.0675 0.1665)
+(-0.0030 0.0675 0.1665)
+(0.0000 0.0675 0.1665)
+(0.0030 0.0675 0.1665)
+(0.0060 0.0675 0.1665)
+(-0.0060 0.0705 0.1665)
+(-0.0030 0.0705 0.1665)
+(0.0000 0.0705 0.1665)
+(0.0030 0.0705 0.1665)
+(0.0060 0.0705 0.1665)
+(-0.0060 0.0735 0.1665)
+(-0.0030 0.0735 0.1665)
+(0.0000 0.0735 0.1665)
+(0.0030 0.0735 0.1665)
+(0.0060 0.0735 0.1665)
+(-0.0060 -0.0735 0.1695)
+(-0.0030 -0.0735 0.1695)
+(0.0000 -0.0735 0.1695)
+(0.0030 -0.0735 0.1695)
+(0.0060 -0.0735 0.1695)
+(-0.0060 -0.0705 0.1695)
+(-0.0030 -0.0705 0.1695)
+(0.0000 -0.0705 0.1695)
+(0.0030 -0.0705 0.1695)
+(0.0060 -0.0705 0.1695)
+(-0.0060 -0.0675 0.1695)
+(-0.0030 -0.0675 0.1695)
+(0.0000 -0.0675 0.1695)
+(0.0030 -0.0675 0.1695)
+(0.0060 -0.0675 0.1695)
+(-0.0060 -0.0645 0.1695)
+(-0.0030 -0.0645 0.1695)
+(0.0000 -0.0645 0.1695)
+(0.0030 -0.0645 0.1695)
+(0.0060 -0.0645 0.1695)
+(-0.0060 -0.0615 0.1695)
+(-0.0030 -0.0615 0.1695)
+(0.0000 -0.0615 0.1695)
+(0.0030 -0.0615 0.1695)
+(0.0060 -0.0615 0.1695)
+(-0.0060 -0.0585 0.1695)
+(-0.0030 -0.0585 0.1695)
+(0.0000 -0.0585 0.1695)
+(0.0030 -0.0585 0.1695)
+(0.0060 -0.0585 0.1695)
+(-0.0060 -0.0555 0.1695)
+(-0.0030 -0.0555 0.1695)
+(0.0000 -0.0555 0.1695)
+(0.0030 -0.0555 0.1695)
+(0.0060 -0.0555 0.1695)
+(-0.0060 -0.0525 0.1695)
+(-0.0030 -0.0525 0.1695)
+(0.0000 -0.0525 0.1695)
+(0.0030 -0.0525 0.1695)
+(0.0060 -0.0525 0.1695)
+(-0.0060 -0.0495 0.1695)
+(-0.0030 -0.0495 0.1695)
+(0.0000 -0.0495 0.1695)
+(0.0030 -0.0495 0.1695)
+(0.0060 -0.0495 0.1695)
+(-0.0060 -0.0465 0.1695)
+(-0.0030 -0.0465 0.1695)
+(0.0000 -0.0465 0.1695)
+(0.0030 -0.0465 0.1695)
+(0.0060 -0.0465 0.1695)
+(-0.0060 -0.0435 0.1695)
+(-0.0030 -0.0435 0.1695)
+(0.0000 -0.0435 0.1695)
+(0.0030 -0.0435 0.1695)
+(0.0060 -0.0435 0.1695)
+(-0.0060 -0.0405 0.1695)
+(-0.0030 -0.0405 0.1695)
+(0.0000 -0.0405 0.1695)
+(0.0030 -0.0405 0.1695)
+(0.0060 -0.0405 0.1695)
+(-0.0060 -0.0375 0.1695)
+(-0.0030 -0.0375 0.1695)
+(0.0000 -0.0375 0.1695)
+(0.0030 -0.0375 0.1695)
+(0.0060 -0.0375 0.1695)
+(-0.0060 -0.0345 0.1695)
+(-0.0030 -0.0345 0.1695)
+(0.0000 -0.0345 0.1695)
+(0.0030 -0.0345 0.1695)
+(0.0060 -0.0345 0.1695)
+(-0.0060 -0.0315 0.1695)
+(-0.0030 -0.0315 0.1695)
+(0.0000 -0.0315 0.1695)
+(0.0030 -0.0315 0.1695)
+(0.0060 -0.0315 0.1695)
+(-0.0060 -0.0285 0.1695)
+(-0.0030 -0.0285 0.1695)
+(0.0000 -0.0285 0.1695)
+(0.0030 -0.0285 0.1695)
+(0.0060 -0.0285 0.1695)
+(-0.0060 -0.0255 0.1695)
+(-0.0030 -0.0255 0.1695)
+(0.0000 -0.0255 0.1695)
+(0.0030 -0.0255 0.1695)
+(0.0060 -0.0255 0.1695)
+(-0.0060 -0.0225 0.1695)
+(-0.0030 -0.0225 0.1695)
+(0.0000 -0.0225 0.1695)
+(0.0030 -0.0225 0.1695)
+(0.0060 -0.0225 0.1695)
+(-0.0060 -0.0195 0.1695)
+(-0.0030 -0.0195 0.1695)
+(0.0000 -0.0195 0.1695)
+(0.0030 -0.0195 0.1695)
+(0.0060 -0.0195 0.1695)
+(-0.0060 -0.0165 0.1695)
+(-0.0030 -0.0165 0.1695)
+(0.0000 -0.0165 0.1695)
+(0.0030 -0.0165 0.1695)
+(0.0060 -0.0165 0.1695)
+(-0.0060 -0.0135 0.1695)
+(-0.0030 -0.0135 0.1695)
+(0.0000 -0.0135 0.1695)
+(0.0030 -0.0135 0.1695)
+(0.0060 -0.0135 0.1695)
+(-0.0060 -0.0105 0.1695)
+(-0.0030 -0.0105 0.1695)
+(0.0000 -0.0105 0.1695)
+(0.0030 -0.0105 0.1695)
+(0.0060 -0.0105 0.1695)
+(-0.0060 -0.0075 0.1695)
+(-0.0030 -0.0075 0.1695)
+(0.0000 -0.0075 0.1695)
+(0.0030 -0.0075 0.1695)
+(0.0060 -0.0075 0.1695)
+(-0.0060 -0.0045 0.1695)
+(-0.0030 -0.0045 0.1695)
+(0.0000 -0.0045 0.1695)
+(0.0030 -0.0045 0.1695)
+(0.0060 -0.0045 0.1695)
+(-0.0060 -0.0015 0.1695)
+(-0.0030 -0.0015 0.1695)
+(0.0000 -0.0015 0.1695)
+(0.0030 -0.0015 0.1695)
+(0.0060 -0.0015 0.1695)
+(-0.0060 0.0015 0.1695)
+(-0.0030 0.0015 0.1695)
+(0.0000 0.0015 0.1695)
+(0.0030 0.0015 0.1695)
+(0.0060 0.0015 0.1695)
+(-0.0060 0.0045 0.1695)
+(-0.0030 0.0045 0.1695)
+(0.0000 0.0045 0.1695)
+(0.0030 0.0045 0.1695)
+(0.0060 0.0045 0.1695)
+(-0.0060 0.0075 0.1695)
+(-0.0030 0.0075 0.1695)
+(0.0000 0.0075 0.1695)
+(0.0030 0.0075 0.1695)
+(0.0060 0.0075 0.1695)
+(-0.0060 0.0105 0.1695)
+(-0.0030 0.0105 0.1695)
+(0.0000 0.0105 0.1695)
+(0.0030 0.0105 0.1695)
+(0.0060 0.0105 0.1695)
+(-0.0060 0.0135 0.1695)
+(-0.0030 0.0135 0.1695)
+(0.0000 0.0135 0.1695)
+(0.0030 0.0135 0.1695)
+(0.0060 0.0135 0.1695)
+(-0.0060 0.0165 0.1695)
+(-0.0030 0.0165 0.1695)
+(0.0000 0.0165 0.1695)
+(0.0030 0.0165 0.1695)
+(0.0060 0.0165 0.1695)
+(-0.0060 0.0195 0.1695)
+(-0.0030 0.0195 0.1695)
+(0.0000 0.0195 0.1695)
+(0.0030 0.0195 0.1695)
+(0.0060 0.0195 0.1695)
+(-0.0060 0.0225 0.1695)
+(-0.0030 0.0225 0.1695)
+(0.0000 0.0225 0.1695)
+(0.0030 0.0225 0.1695)
+(0.0060 0.0225 0.1695)
+(-0.0060 0.0255 0.1695)
+(-0.0030 0.0255 0.1695)
+(0.0000 0.0255 0.1695)
+(0.0030 0.0255 0.1695)
+(0.0060 0.0255 0.1695)
+(-0.0060 0.0285 0.1695)
+(-0.0030 0.0285 0.1695)
+(0.0000 0.0285 0.1695)
+(0.0030 0.0285 0.1695)
+(0.0060 0.0285 0.1695)
+(-0.0060 0.0315 0.1695)
+(-0.0030 0.0315 0.1695)
+(0.0000 0.0315 0.1695)
+(0.0030 0.0315 0.1695)
+(0.0060 0.0315 0.1695)
+(-0.0060 0.0345 0.1695)
+(-0.0030 0.0345 0.1695)
+(0.0000 0.0345 0.1695)
+(0.0030 0.0345 0.1695)
+(0.0060 0.0345 0.1695)
+(-0.0060 0.0375 0.1695)
+(-0.0030 0.0375 0.1695)
+(0.0000 0.0375 0.1695)
+(0.0030 0.0375 0.1695)
+(0.0060 0.0375 0.1695)
+(-0.0060 0.0405 0.1695)
+(-0.0030 0.0405 0.1695)
+(0.0000 0.0405 0.1695)
+(0.0030 0.0405 0.1695)
+(0.0060 0.0405 0.1695)
+(-0.0060 0.0435 0.1695)
+(-0.0030 0.0435 0.1695)
+(0.0000 0.0435 0.1695)
+(0.0030 0.0435 0.1695)
+(0.0060 0.0435 0.1695)
+(-0.0060 0.0465 0.1695)
+(-0.0030 0.0465 0.1695)
+(0.0000 0.0465 0.1695)
+(0.0030 0.0465 0.1695)
+(0.0060 0.0465 0.1695)
+(-0.0060 0.0495 0.1695)
+(-0.0030 0.0495 0.1695)
+(0.0000 0.0495 0.1695)
+(0.0030 0.0495 0.1695)
+(0.0060 0.0495 0.1695)
+(-0.0060 0.0525 0.1695)
+(-0.0030 0.0525 0.1695)
+(0.0000 0.0525 0.1695)
+(0.0030 0.0525 0.1695)
+(0.0060 0.0525 0.1695)
+(-0.0060 0.0555 0.1695)
+(-0.0030 0.0555 0.1695)
+(0.0000 0.0555 0.1695)
+(0.0030 0.0555 0.1695)
+(0.0060 0.0555 0.1695)
+(-0.0060 0.0585 0.1695)
+(-0.0030 0.0585 0.1695)
+(0.0000 0.0585 0.1695)
+(0.0030 0.0585 0.1695)
+(0.0060 0.0585 0.1695)
+(-0.0060 0.0615 0.1695)
+(-0.0030 0.0615 0.1695)
+(0.0000 0.0615 0.1695)
+(0.0030 0.0615 0.1695)
+(0.0060 0.0615 0.1695)
+(-0.0060 0.0645 0.1695)
+(-0.0030 0.0645 0.1695)
+(0.0000 0.0645 0.1695)
+(0.0030 0.0645 0.1695)
+(0.0060 0.0645 0.1695)
+(-0.0060 0.0675 0.1695)
+(-0.0030 0.0675 0.1695)
+(0.0000 0.0675 0.1695)
+(0.0030 0.0675 0.1695)
+(0.0060 0.0675 0.1695)
+(-0.0060 0.0705 0.1695)
+(-0.0030 0.0705 0.1695)
+(0.0000 0.0705 0.1695)
+(0.0030 0.0705 0.1695)
+(0.0060 0.0705 0.1695)
+(-0.0060 0.0735 0.1695)
+(-0.0030 0.0735 0.1695)
+(0.0000 0.0735 0.1695)
+(0.0030 0.0735 0.1695)
+(0.0060 0.0735 0.1695)
+(-0.0060 -0.0735 0.1725)
+(-0.0030 -0.0735 0.1725)
+(0.0000 -0.0735 0.1725)
+(0.0030 -0.0735 0.1725)
+(0.0060 -0.0735 0.1725)
+(-0.0060 -0.0705 0.1725)
+(-0.0030 -0.0705 0.1725)
+(0.0000 -0.0705 0.1725)
+(0.0030 -0.0705 0.1725)
+(0.0060 -0.0705 0.1725)
+(-0.0060 -0.0675 0.1725)
+(-0.0030 -0.0675 0.1725)
+(0.0000 -0.0675 0.1725)
+(0.0030 -0.0675 0.1725)
+(0.0060 -0.0675 0.1725)
+(-0.0060 -0.0645 0.1725)
+(-0.0030 -0.0645 0.1725)
+(0.0000 -0.0645 0.1725)
+(0.0030 -0.0645 0.1725)
+(0.0060 -0.0645 0.1725)
+(-0.0060 -0.0615 0.1725)
+(-0.0030 -0.0615 0.1725)
+(0.0000 -0.0615 0.1725)
+(0.0030 -0.0615 0.1725)
+(0.0060 -0.0615 0.1725)
+(-0.0060 -0.0585 0.1725)
+(-0.0030 -0.0585 0.1725)
+(0.0000 -0.0585 0.1725)
+(0.0030 -0.0585 0.1725)
+(0.0060 -0.0585 0.1725)
+(-0.0060 -0.0555 0.1725)
+(-0.0030 -0.0555 0.1725)
+(0.0000 -0.0555 0.1725)
+(0.0030 -0.0555 0.1725)
+(0.0060 -0.0555 0.1725)
+(-0.0060 -0.0525 0.1725)
+(-0.0030 -0.0525 0.1725)
+(0.0000 -0.0525 0.1725)
+(0.0030 -0.0525 0.1725)
+(0.0060 -0.0525 0.1725)
+(-0.0060 -0.0495 0.1725)
+(-0.0030 -0.0495 0.1725)
+(0.0000 -0.0495 0.1725)
+(0.0030 -0.0495 0.1725)
+(0.0060 -0.0495 0.1725)
+(-0.0060 -0.0465 0.1725)
+(-0.0030 -0.0465 0.1725)
+(0.0000 -0.0465 0.1725)
+(0.0030 -0.0465 0.1725)
+(0.0060 -0.0465 0.1725)
+(-0.0060 -0.0435 0.1725)
+(-0.0030 -0.0435 0.1725)
+(0.0000 -0.0435 0.1725)
+(0.0030 -0.0435 0.1725)
+(0.0060 -0.0435 0.1725)
+(-0.0060 -0.0405 0.1725)
+(-0.0030 -0.0405 0.1725)
+(0.0000 -0.0405 0.1725)
+(0.0030 -0.0405 0.1725)
+(0.0060 -0.0405 0.1725)
+(-0.0060 -0.0375 0.1725)
+(-0.0030 -0.0375 0.1725)
+(0.0000 -0.0375 0.1725)
+(0.0030 -0.0375 0.1725)
+(0.0060 -0.0375 0.1725)
+(-0.0060 -0.0345 0.1725)
+(-0.0030 -0.0345 0.1725)
+(0.0000 -0.0345 0.1725)
+(0.0030 -0.0345 0.1725)
+(0.0060 -0.0345 0.1725)
+(-0.0060 -0.0315 0.1725)
+(-0.0030 -0.0315 0.1725)
+(0.0000 -0.0315 0.1725)
+(0.0030 -0.0315 0.1725)
+(0.0060 -0.0315 0.1725)
+(-0.0060 -0.0285 0.1725)
+(-0.0030 -0.0285 0.1725)
+(0.0000 -0.0285 0.1725)
+(0.0030 -0.0285 0.1725)
+(0.0060 -0.0285 0.1725)
+(-0.0060 -0.0255 0.1725)
+(-0.0030 -0.0255 0.1725)
+(0.0000 -0.0255 0.1725)
+(0.0030 -0.0255 0.1725)
+(0.0060 -0.0255 0.1725)
+(-0.0060 -0.0225 0.1725)
+(-0.0030 -0.0225 0.1725)
+(0.0000 -0.0225 0.1725)
+(0.0030 -0.0225 0.1725)
+(0.0060 -0.0225 0.1725)
+(-0.0060 -0.0195 0.1725)
+(-0.0030 -0.0195 0.1725)
+(0.0000 -0.0195 0.1725)
+(0.0030 -0.0195 0.1725)
+(0.0060 -0.0195 0.1725)
+(-0.0060 -0.0165 0.1725)
+(-0.0030 -0.0165 0.1725)
+(0.0000 -0.0165 0.1725)
+(0.0030 -0.0165 0.1725)
+(0.0060 -0.0165 0.1725)
+(-0.0060 -0.0135 0.1725)
+(-0.0030 -0.0135 0.1725)
+(0.0000 -0.0135 0.1725)
+(0.0030 -0.0135 0.1725)
+(0.0060 -0.0135 0.1725)
+(-0.0060 -0.0105 0.1725)
+(-0.0030 -0.0105 0.1725)
+(0.0000 -0.0105 0.1725)
+(0.0030 -0.0105 0.1725)
+(0.0060 -0.0105 0.1725)
+(-0.0060 -0.0075 0.1725)
+(-0.0030 -0.0075 0.1725)
+(0.0000 -0.0075 0.1725)
+(0.0030 -0.0075 0.1725)
+(0.0060 -0.0075 0.1725)
+(-0.0060 -0.0045 0.1725)
+(-0.0030 -0.0045 0.1725)
+(0.0000 -0.0045 0.1725)
+(0.0030 -0.0045 0.1725)
+(0.0060 -0.0045 0.1725)
+(-0.0060 -0.0015 0.1725)
+(-0.0030 -0.0015 0.1725)
+(0.0000 -0.0015 0.1725)
+(0.0030 -0.0015 0.1725)
+(0.0060 -0.0015 0.1725)
+(-0.0060 0.0015 0.1725)
+(-0.0030 0.0015 0.1725)
+(0.0000 0.0015 0.1725)
+(0.0030 0.0015 0.1725)
+(0.0060 0.0015 0.1725)
+(-0.0060 0.0045 0.1725)
+(-0.0030 0.0045 0.1725)
+(0.0000 0.0045 0.1725)
+(0.0030 0.0045 0.1725)
+(0.0060 0.0045 0.1725)
+(-0.0060 0.0075 0.1725)
+(-0.0030 0.0075 0.1725)
+(0.0000 0.0075 0.1725)
+(0.0030 0.0075 0.1725)
+(0.0060 0.0075 0.1725)
+(-0.0060 0.0105 0.1725)
+(-0.0030 0.0105 0.1725)
+(0.0000 0.0105 0.1725)
+(0.0030 0.0105 0.1725)
+(0.0060 0.0105 0.1725)
+(-0.0060 0.0135 0.1725)
+(-0.0030 0.0135 0.1725)
+(0.0000 0.0135 0.1725)
+(0.0030 0.0135 0.1725)
+(0.0060 0.0135 0.1725)
+(-0.0060 0.0165 0.1725)
+(-0.0030 0.0165 0.1725)
+(0.0000 0.0165 0.1725)
+(0.0030 0.0165 0.1725)
+(0.0060 0.0165 0.1725)
+(-0.0060 0.0195 0.1725)
+(-0.0030 0.0195 0.1725)
+(0.0000 0.0195 0.1725)
+(0.0030 0.0195 0.1725)
+(0.0060 0.0195 0.1725)
+(-0.0060 0.0225 0.1725)
+(-0.0030 0.0225 0.1725)
+(0.0000 0.0225 0.1725)
+(0.0030 0.0225 0.1725)
+(0.0060 0.0225 0.1725)
+(-0.0060 0.0255 0.1725)
+(-0.0030 0.0255 0.1725)
+(0.0000 0.0255 0.1725)
+(0.0030 0.0255 0.1725)
+(0.0060 0.0255 0.1725)
+(-0.0060 0.0285 0.1725)
+(-0.0030 0.0285 0.1725)
+(0.0000 0.0285 0.1725)
+(0.0030 0.0285 0.1725)
+(0.0060 0.0285 0.1725)
+(-0.0060 0.0315 0.1725)
+(-0.0030 0.0315 0.1725)
+(0.0000 0.0315 0.1725)
+(0.0030 0.0315 0.1725)
+(0.0060 0.0315 0.1725)
+(-0.0060 0.0345 0.1725)
+(-0.0030 0.0345 0.1725)
+(0.0000 0.0345 0.1725)
+(0.0030 0.0345 0.1725)
+(0.0060 0.0345 0.1725)
+(-0.0060 0.0375 0.1725)
+(-0.0030 0.0375 0.1725)
+(0.0000 0.0375 0.1725)
+(0.0030 0.0375 0.1725)
+(0.0060 0.0375 0.1725)
+(-0.0060 0.0405 0.1725)
+(-0.0030 0.0405 0.1725)
+(0.0000 0.0405 0.1725)
+(0.0030 0.0405 0.1725)
+(0.0060 0.0405 0.1725)
+(-0.0060 0.0435 0.1725)
+(-0.0030 0.0435 0.1725)
+(0.0000 0.0435 0.1725)
+(0.0030 0.0435 0.1725)
+(0.0060 0.0435 0.1725)
+(-0.0060 0.0465 0.1725)
+(-0.0030 0.0465 0.1725)
+(0.0000 0.0465 0.1725)
+(0.0030 0.0465 0.1725)
+(0.0060 0.0465 0.1725)
+(-0.0060 0.0495 0.1725)
+(-0.0030 0.0495 0.1725)
+(0.0000 0.0495 0.1725)
+(0.0030 0.0495 0.1725)
+(0.0060 0.0495 0.1725)
+(-0.0060 0.0525 0.1725)
+(-0.0030 0.0525 0.1725)
+(0.0000 0.0525 0.1725)
+(0.0030 0.0525 0.1725)
+(0.0060 0.0525 0.1725)
+(-0.0060 0.0555 0.1725)
+(-0.0030 0.0555 0.1725)
+(0.0000 0.0555 0.1725)
+(0.0030 0.0555 0.1725)
+(0.0060 0.0555 0.1725)
+(-0.0060 0.0585 0.1725)
+(-0.0030 0.0585 0.1725)
+(0.0000 0.0585 0.1725)
+(0.0030 0.0585 0.1725)
+(0.0060 0.0585 0.1725)
+(-0.0060 0.0615 0.1725)
+(-0.0030 0.0615 0.1725)
+(0.0000 0.0615 0.1725)
+(0.0030 0.0615 0.1725)
+(0.0060 0.0615 0.1725)
+(-0.0060 0.0645 0.1725)
+(-0.0030 0.0645 0.1725)
+(0.0000 0.0645 0.1725)
+(0.0030 0.0645 0.1725)
+(0.0060 0.0645 0.1725)
+(-0.0060 0.0675 0.1725)
+(-0.0030 0.0675 0.1725)
+(0.0000 0.0675 0.1725)
+(0.0030 0.0675 0.1725)
+(0.0060 0.0675 0.1725)
+(-0.0060 0.0705 0.1725)
+(-0.0030 0.0705 0.1725)
+(0.0000 0.0705 0.1725)
+(0.0030 0.0705 0.1725)
+(0.0060 0.0705 0.1725)
+(-0.0060 0.0735 0.1725)
+(-0.0030 0.0735 0.1725)
+(0.0000 0.0735 0.1725)
+(0.0030 0.0735 0.1725)
+(0.0060 0.0735 0.1725)
+(-0.0060 -0.0735 0.1755)
+(-0.0030 -0.0735 0.1755)
+(0.0000 -0.0735 0.1755)
+(0.0030 -0.0735 0.1755)
+(0.0060 -0.0735 0.1755)
+(-0.0060 -0.0705 0.1755)
+(-0.0030 -0.0705 0.1755)
+(0.0000 -0.0705 0.1755)
+(0.0030 -0.0705 0.1755)
+(0.0060 -0.0705 0.1755)
+(-0.0060 -0.0675 0.1755)
+(-0.0030 -0.0675 0.1755)
+(0.0000 -0.0675 0.1755)
+(0.0030 -0.0675 0.1755)
+(0.0060 -0.0675 0.1755)
+(-0.0060 -0.0645 0.1755)
+(-0.0030 -0.0645 0.1755)
+(0.0000 -0.0645 0.1755)
+(0.0030 -0.0645 0.1755)
+(0.0060 -0.0645 0.1755)
+(-0.0060 -0.0615 0.1755)
+(-0.0030 -0.0615 0.1755)
+(0.0000 -0.0615 0.1755)
+(0.0030 -0.0615 0.1755)
+(0.0060 -0.0615 0.1755)
+(-0.0060 -0.0585 0.1755)
+(-0.0030 -0.0585 0.1755)
+(0.0000 -0.0585 0.1755)
+(0.0030 -0.0585 0.1755)
+(0.0060 -0.0585 0.1755)
+(-0.0060 -0.0555 0.1755)
+(-0.0030 -0.0555 0.1755)
+(0.0000 -0.0555 0.1755)
+(0.0030 -0.0555 0.1755)
+(0.0060 -0.0555 0.1755)
+(-0.0060 -0.0525 0.1755)
+(-0.0030 -0.0525 0.1755)
+(0.0000 -0.0525 0.1755)
+(0.0030 -0.0525 0.1755)
+(0.0060 -0.0525 0.1755)
+(-0.0060 -0.0495 0.1755)
+(-0.0030 -0.0495 0.1755)
+(0.0000 -0.0495 0.1755)
+(0.0030 -0.0495 0.1755)
+(0.0060 -0.0495 0.1755)
+(-0.0060 -0.0465 0.1755)
+(-0.0030 -0.0465 0.1755)
+(0.0000 -0.0465 0.1755)
+(0.0030 -0.0465 0.1755)
+(0.0060 -0.0465 0.1755)
+(-0.0060 -0.0435 0.1755)
+(-0.0030 -0.0435 0.1755)
+(0.0000 -0.0435 0.1755)
+(0.0030 -0.0435 0.1755)
+(0.0060 -0.0435 0.1755)
+(-0.0060 -0.0405 0.1755)
+(-0.0030 -0.0405 0.1755)
+(0.0000 -0.0405 0.1755)
+(0.0030 -0.0405 0.1755)
+(0.0060 -0.0405 0.1755)
+(-0.0060 -0.0375 0.1755)
+(-0.0030 -0.0375 0.1755)
+(0.0000 -0.0375 0.1755)
+(0.0030 -0.0375 0.1755)
+(0.0060 -0.0375 0.1755)
+(-0.0060 -0.0345 0.1755)
+(-0.0030 -0.0345 0.1755)
+(0.0000 -0.0345 0.1755)
+(0.0030 -0.0345 0.1755)
+(0.0060 -0.0345 0.1755)
+(-0.0060 -0.0315 0.1755)
+(-0.0030 -0.0315 0.1755)
+(0.0000 -0.0315 0.1755)
+(0.0030 -0.0315 0.1755)
+(0.0060 -0.0315 0.1755)
+(-0.0060 -0.0285 0.1755)
+(-0.0030 -0.0285 0.1755)
+(0.0000 -0.0285 0.1755)
+(0.0030 -0.0285 0.1755)
+(0.0060 -0.0285 0.1755)
+(-0.0060 -0.0255 0.1755)
+(-0.0030 -0.0255 0.1755)
+(0.0000 -0.0255 0.1755)
+(0.0030 -0.0255 0.1755)
+(0.0060 -0.0255 0.1755)
+(-0.0060 -0.0225 0.1755)
+(-0.0030 -0.0225 0.1755)
+(0.0000 -0.0225 0.1755)
+(0.0030 -0.0225 0.1755)
+(0.0060 -0.0225 0.1755)
+(-0.0060 -0.0195 0.1755)
+(-0.0030 -0.0195 0.1755)
+(0.0000 -0.0195 0.1755)
+(0.0030 -0.0195 0.1755)
+(0.0060 -0.0195 0.1755)
+(-0.0060 -0.0165 0.1755)
+(-0.0030 -0.0165 0.1755)
+(0.0000 -0.0165 0.1755)
+(0.0030 -0.0165 0.1755)
+(0.0060 -0.0165 0.1755)
+(-0.0060 -0.0135 0.1755)
+(-0.0030 -0.0135 0.1755)
+(0.0000 -0.0135 0.1755)
+(0.0030 -0.0135 0.1755)
+(0.0060 -0.0135 0.1755)
+(-0.0060 -0.0105 0.1755)
+(-0.0030 -0.0105 0.1755)
+(0.0000 -0.0105 0.1755)
+(0.0030 -0.0105 0.1755)
+(0.0060 -0.0105 0.1755)
+(-0.0060 -0.0075 0.1755)
+(-0.0030 -0.0075 0.1755)
+(0.0000 -0.0075 0.1755)
+(0.0030 -0.0075 0.1755)
+(0.0060 -0.0075 0.1755)
+(-0.0060 -0.0045 0.1755)
+(-0.0030 -0.0045 0.1755)
+(0.0000 -0.0045 0.1755)
+(0.0030 -0.0045 0.1755)
+(0.0060 -0.0045 0.1755)
+(-0.0060 -0.0015 0.1755)
+(-0.0030 -0.0015 0.1755)
+(0.0000 -0.0015 0.1755)
+(0.0030 -0.0015 0.1755)
+(0.0060 -0.0015 0.1755)
+(-0.0060 0.0015 0.1755)
+(-0.0030 0.0015 0.1755)
+(0.0000 0.0015 0.1755)
+(0.0030 0.0015 0.1755)
+(0.0060 0.0015 0.1755)
+(-0.0060 0.0045 0.1755)
+(-0.0030 0.0045 0.1755)
+(0.0000 0.0045 0.1755)
+(0.0030 0.0045 0.1755)
+(0.0060 0.0045 0.1755)
+(-0.0060 0.0075 0.1755)
+(-0.0030 0.0075 0.1755)
+(0.0000 0.0075 0.1755)
+(0.0030 0.0075 0.1755)
+(0.0060 0.0075 0.1755)
+(-0.0060 0.0105 0.1755)
+(-0.0030 0.0105 0.1755)
+(0.0000 0.0105 0.1755)
+(0.0030 0.0105 0.1755)
+(0.0060 0.0105 0.1755)
+(-0.0060 0.0135 0.1755)
+(-0.0030 0.0135 0.1755)
+(0.0000 0.0135 0.1755)
+(0.0030 0.0135 0.1755)
+(0.0060 0.0135 0.1755)
+(-0.0060 0.0165 0.1755)
+(-0.0030 0.0165 0.1755)
+(0.0000 0.0165 0.1755)
+(0.0030 0.0165 0.1755)
+(0.0060 0.0165 0.1755)
+(-0.0060 0.0195 0.1755)
+(-0.0030 0.0195 0.1755)
+(0.0000 0.0195 0.1755)
+(0.0030 0.0195 0.1755)
+(0.0060 0.0195 0.1755)
+(-0.0060 0.0225 0.1755)
+(-0.0030 0.0225 0.1755)
+(0.0000 0.0225 0.1755)
+(0.0030 0.0225 0.1755)
+(0.0060 0.0225 0.1755)
+(-0.0060 0.0255 0.1755)
+(-0.0030 0.0255 0.1755)
+(0.0000 0.0255 0.1755)
+(0.0030 0.0255 0.1755)
+(0.0060 0.0255 0.1755)
+(-0.0060 0.0285 0.1755)
+(-0.0030 0.0285 0.1755)
+(0.0000 0.0285 0.1755)
+(0.0030 0.0285 0.1755)
+(0.0060 0.0285 0.1755)
+(-0.0060 0.0315 0.1755)
+(-0.0030 0.0315 0.1755)
+(0.0000 0.0315 0.1755)
+(0.0030 0.0315 0.1755)
+(0.0060 0.0315 0.1755)
+(-0.0060 0.0345 0.1755)
+(-0.0030 0.0345 0.1755)
+(0.0000 0.0345 0.1755)
+(0.0030 0.0345 0.1755)
+(0.0060 0.0345 0.1755)
+(-0.0060 0.0375 0.1755)
+(-0.0030 0.0375 0.1755)
+(0.0000 0.0375 0.1755)
+(0.0030 0.0375 0.1755)
+(0.0060 0.0375 0.1755)
+(-0.0060 0.0405 0.1755)
+(-0.0030 0.0405 0.1755)
+(0.0000 0.0405 0.1755)
+(0.0030 0.0405 0.1755)
+(0.0060 0.0405 0.1755)
+(-0.0060 0.0435 0.1755)
+(-0.0030 0.0435 0.1755)
+(0.0000 0.0435 0.1755)
+(0.0030 0.0435 0.1755)
+(0.0060 0.0435 0.1755)
+(-0.0060 0.0465 0.1755)
+(-0.0030 0.0465 0.1755)
+(0.0000 0.0465 0.1755)
+(0.0030 0.0465 0.1755)
+(0.0060 0.0465 0.1755)
+(-0.0060 0.0495 0.1755)
+(-0.0030 0.0495 0.1755)
+(0.0000 0.0495 0.1755)
+(0.0030 0.0495 0.1755)
+(0.0060 0.0495 0.1755)
+(-0.0060 0.0525 0.1755)
+(-0.0030 0.0525 0.1755)
+(0.0000 0.0525 0.1755)
+(0.0030 0.0525 0.1755)
+(0.0060 0.0525 0.1755)
+(-0.0060 0.0555 0.1755)
+(-0.0030 0.0555 0.1755)
+(0.0000 0.0555 0.1755)
+(0.0030 0.0555 0.1755)
+(0.0060 0.0555 0.1755)
+(-0.0060 0.0585 0.1755)
+(-0.0030 0.0585 0.1755)
+(0.0000 0.0585 0.1755)
+(0.0030 0.0585 0.1755)
+(0.0060 0.0585 0.1755)
+(-0.0060 0.0615 0.1755)
+(-0.0030 0.0615 0.1755)
+(0.0000 0.0615 0.1755)
+(0.0030 0.0615 0.1755)
+(0.0060 0.0615 0.1755)
+(-0.0060 0.0645 0.1755)
+(-0.0030 0.0645 0.1755)
+(0.0000 0.0645 0.1755)
+(0.0030 0.0645 0.1755)
+(0.0060 0.0645 0.1755)
+(-0.0060 0.0675 0.1755)
+(-0.0030 0.0675 0.1755)
+(0.0000 0.0675 0.1755)
+(0.0030 0.0675 0.1755)
+(0.0060 0.0675 0.1755)
+(-0.0060 0.0705 0.1755)
+(-0.0030 0.0705 0.1755)
+(0.0000 0.0705 0.1755)
+(0.0030 0.0705 0.1755)
+(0.0060 0.0705 0.1755)
+(-0.0060 0.0735 0.1755)
+(-0.0030 0.0735 0.1755)
+(0.0000 0.0735 0.1755)
+(0.0030 0.0735 0.1755)
+(0.0060 0.0735 0.1755)
+(-0.0060 -0.0735 0.1785)
+(-0.0030 -0.0735 0.1785)
+(0.0000 -0.0735 0.1785)
+(0.0030 -0.0735 0.1785)
+(0.0060 -0.0735 0.1785)
+(-0.0060 -0.0705 0.1785)
+(-0.0030 -0.0705 0.1785)
+(0.0000 -0.0705 0.1785)
+(0.0030 -0.0705 0.1785)
+(0.0060 -0.0705 0.1785)
+(-0.0060 -0.0675 0.1785)
+(-0.0030 -0.0675 0.1785)
+(0.0000 -0.0675 0.1785)
+(0.0030 -0.0675 0.1785)
+(0.0060 -0.0675 0.1785)
+(-0.0060 -0.0645 0.1785)
+(-0.0030 -0.0645 0.1785)
+(0.0000 -0.0645 0.1785)
+(0.0030 -0.0645 0.1785)
+(0.0060 -0.0645 0.1785)
+(-0.0060 -0.0615 0.1785)
+(-0.0030 -0.0615 0.1785)
+(0.0000 -0.0615 0.1785)
+(0.0030 -0.0615 0.1785)
+(0.0060 -0.0615 0.1785)
+(-0.0060 -0.0585 0.1785)
+(-0.0030 -0.0585 0.1785)
+(0.0000 -0.0585 0.1785)
+(0.0030 -0.0585 0.1785)
+(0.0060 -0.0585 0.1785)
+(-0.0060 -0.0555 0.1785)
+(-0.0030 -0.0555 0.1785)
+(0.0000 -0.0555 0.1785)
+(0.0030 -0.0555 0.1785)
+(0.0060 -0.0555 0.1785)
+(-0.0060 -0.0525 0.1785)
+(-0.0030 -0.0525 0.1785)
+(0.0000 -0.0525 0.1785)
+(0.0030 -0.0525 0.1785)
+(0.0060 -0.0525 0.1785)
+(-0.0060 -0.0495 0.1785)
+(-0.0030 -0.0495 0.1785)
+(0.0000 -0.0495 0.1785)
+(0.0030 -0.0495 0.1785)
+(0.0060 -0.0495 0.1785)
+(-0.0060 -0.0465 0.1785)
+(-0.0030 -0.0465 0.1785)
+(0.0000 -0.0465 0.1785)
+(0.0030 -0.0465 0.1785)
+(0.0060 -0.0465 0.1785)
+(-0.0060 -0.0435 0.1785)
+(-0.0030 -0.0435 0.1785)
+(0.0000 -0.0435 0.1785)
+(0.0030 -0.0435 0.1785)
+(0.0060 -0.0435 0.1785)
+(-0.0060 -0.0405 0.1785)
+(-0.0030 -0.0405 0.1785)
+(0.0000 -0.0405 0.1785)
+(0.0030 -0.0405 0.1785)
+(0.0060 -0.0405 0.1785)
+(-0.0060 -0.0375 0.1785)
+(-0.0030 -0.0375 0.1785)
+(0.0000 -0.0375 0.1785)
+(0.0030 -0.0375 0.1785)
+(0.0060 -0.0375 0.1785)
+(-0.0060 -0.0345 0.1785)
+(-0.0030 -0.0345 0.1785)
+(0.0000 -0.0345 0.1785)
+(0.0030 -0.0345 0.1785)
+(0.0060 -0.0345 0.1785)
+(-0.0060 -0.0315 0.1785)
+(-0.0030 -0.0315 0.1785)
+(0.0000 -0.0315 0.1785)
+(0.0030 -0.0315 0.1785)
+(0.0060 -0.0315 0.1785)
+(-0.0060 -0.0285 0.1785)
+(-0.0030 -0.0285 0.1785)
+(0.0000 -0.0285 0.1785)
+(0.0030 -0.0285 0.1785)
+(0.0060 -0.0285 0.1785)
+(-0.0060 -0.0255 0.1785)
+(-0.0030 -0.0255 0.1785)
+(0.0000 -0.0255 0.1785)
+(0.0030 -0.0255 0.1785)
+(0.0060 -0.0255 0.1785)
+(-0.0060 -0.0225 0.1785)
+(-0.0030 -0.0225 0.1785)
+(0.0000 -0.0225 0.1785)
+(0.0030 -0.0225 0.1785)
+(0.0060 -0.0225 0.1785)
+(-0.0060 -0.0195 0.1785)
+(-0.0030 -0.0195 0.1785)
+(0.0000 -0.0195 0.1785)
+(0.0030 -0.0195 0.1785)
+(0.0060 -0.0195 0.1785)
+(-0.0060 -0.0165 0.1785)
+(-0.0030 -0.0165 0.1785)
+(0.0000 -0.0165 0.1785)
+(0.0030 -0.0165 0.1785)
+(0.0060 -0.0165 0.1785)
+(-0.0060 -0.0135 0.1785)
+(-0.0030 -0.0135 0.1785)
+(0.0000 -0.0135 0.1785)
+(0.0030 -0.0135 0.1785)
+(0.0060 -0.0135 0.1785)
+(-0.0060 -0.0105 0.1785)
+(-0.0030 -0.0105 0.1785)
+(0.0000 -0.0105 0.1785)
+(0.0030 -0.0105 0.1785)
+(0.0060 -0.0105 0.1785)
+(-0.0060 -0.0075 0.1785)
+(-0.0030 -0.0075 0.1785)
+(0.0000 -0.0075 0.1785)
+(0.0030 -0.0075 0.1785)
+(0.0060 -0.0075 0.1785)
+(-0.0060 -0.0045 0.1785)
+(-0.0030 -0.0045 0.1785)
+(0.0000 -0.0045 0.1785)
+(0.0030 -0.0045 0.1785)
+(0.0060 -0.0045 0.1785)
+(-0.0060 -0.0015 0.1785)
+(-0.0030 -0.0015 0.1785)
+(0.0000 -0.0015 0.1785)
+(0.0030 -0.0015 0.1785)
+(0.0060 -0.0015 0.1785)
+(-0.0060 0.0015 0.1785)
+(-0.0030 0.0015 0.1785)
+(0.0000 0.0015 0.1785)
+(0.0030 0.0015 0.1785)
+(0.0060 0.0015 0.1785)
+(-0.0060 0.0045 0.1785)
+(-0.0030 0.0045 0.1785)
+(0.0000 0.0045 0.1785)
+(0.0030 0.0045 0.1785)
+(0.0060 0.0045 0.1785)
+(-0.0060 0.0075 0.1785)
+(-0.0030 0.0075 0.1785)
+(0.0000 0.0075 0.1785)
+(0.0030 0.0075 0.1785)
+(0.0060 0.0075 0.1785)
+(-0.0060 0.0105 0.1785)
+(-0.0030 0.0105 0.1785)
+(0.0000 0.0105 0.1785)
+(0.0030 0.0105 0.1785)
+(0.0060 0.0105 0.1785)
+(-0.0060 0.0135 0.1785)
+(-0.0030 0.0135 0.1785)
+(0.0000 0.0135 0.1785)
+(0.0030 0.0135 0.1785)
+(0.0060 0.0135 0.1785)
+(-0.0060 0.0165 0.1785)
+(-0.0030 0.0165 0.1785)
+(0.0000 0.0165 0.1785)
+(0.0030 0.0165 0.1785)
+(0.0060 0.0165 0.1785)
+(-0.0060 0.0195 0.1785)
+(-0.0030 0.0195 0.1785)
+(0.0000 0.0195 0.1785)
+(0.0030 0.0195 0.1785)
+(0.0060 0.0195 0.1785)
+(-0.0060 0.0225 0.1785)
+(-0.0030 0.0225 0.1785)
+(0.0000 0.0225 0.1785)
+(0.0030 0.0225 0.1785)
+(0.0060 0.0225 0.1785)
+(-0.0060 0.0255 0.1785)
+(-0.0030 0.0255 0.1785)
+(0.0000 0.0255 0.1785)
+(0.0030 0.0255 0.1785)
+(0.0060 0.0255 0.1785)
+(-0.0060 0.0285 0.1785)
+(-0.0030 0.0285 0.1785)
+(0.0000 0.0285 0.1785)
+(0.0030 0.0285 0.1785)
+(0.0060 0.0285 0.1785)
+(-0.0060 0.0315 0.1785)
+(-0.0030 0.0315 0.1785)
+(0.0000 0.0315 0.1785)
+(0.0030 0.0315 0.1785)
+(0.0060 0.0315 0.1785)
+(-0.0060 0.0345 0.1785)
+(-0.0030 0.0345 0.1785)
+(0.0000 0.0345 0.1785)
+(0.0030 0.0345 0.1785)
+(0.0060 0.0345 0.1785)
+(-0.0060 0.0375 0.1785)
+(-0.0030 0.0375 0.1785)
+(0.0000 0.0375 0.1785)
+(0.0030 0.0375 0.1785)
+(0.0060 0.0375 0.1785)
+(-0.0060 0.0405 0.1785)
+(-0.0030 0.0405 0.1785)
+(0.0000 0.0405 0.1785)
+(0.0030 0.0405 0.1785)
+(0.0060 0.0405 0.1785)
+(-0.0060 0.0435 0.1785)
+(-0.0030 0.0435 0.1785)
+(0.0000 0.0435 0.1785)
+(0.0030 0.0435 0.1785)
+(0.0060 0.0435 0.1785)
+(-0.0060 0.0465 0.1785)
+(-0.0030 0.0465 0.1785)
+(0.0000 0.0465 0.1785)
+(0.0030 0.0465 0.1785)
+(0.0060 0.0465 0.1785)
+(-0.0060 0.0495 0.1785)
+(-0.0030 0.0495 0.1785)
+(0.0000 0.0495 0.1785)
+(0.0030 0.0495 0.1785)
+(0.0060 0.0495 0.1785)
+(-0.0060 0.0525 0.1785)
+(-0.0030 0.0525 0.1785)
+(0.0000 0.0525 0.1785)
+(0.0030 0.0525 0.1785)
+(0.0060 0.0525 0.1785)
+(-0.0060 0.0555 0.1785)
+(-0.0030 0.0555 0.1785)
+(0.0000 0.0555 0.1785)
+(0.0030 0.0555 0.1785)
+(0.0060 0.0555 0.1785)
+(-0.0060 0.0585 0.1785)
+(-0.0030 0.0585 0.1785)
+(0.0000 0.0585 0.1785)
+(0.0030 0.0585 0.1785)
+(0.0060 0.0585 0.1785)
+(-0.0060 0.0615 0.1785)
+(-0.0030 0.0615 0.1785)
+(0.0000 0.0615 0.1785)
+(0.0030 0.0615 0.1785)
+(0.0060 0.0615 0.1785)
+(-0.0060 0.0645 0.1785)
+(-0.0030 0.0645 0.1785)
+(0.0000 0.0645 0.1785)
+(0.0030 0.0645 0.1785)
+(0.0060 0.0645 0.1785)
+(-0.0060 0.0675 0.1785)
+(-0.0030 0.0675 0.1785)
+(0.0000 0.0675 0.1785)
+(0.0030 0.0675 0.1785)
+(0.0060 0.0675 0.1785)
+(-0.0060 0.0705 0.1785)
+(-0.0030 0.0705 0.1785)
+(0.0000 0.0705 0.1785)
+(0.0030 0.0705 0.1785)
+(0.0060 0.0705 0.1785)
+(-0.0060 0.0735 0.1785)
+(-0.0030 0.0735 0.1785)
+(0.0000 0.0735 0.1785)
+(0.0030 0.0735 0.1785)
+(0.0060 0.0735 0.1785)
+(-0.0060 -0.0735 0.1815)
+(-0.0030 -0.0735 0.1815)
+(0.0000 -0.0735 0.1815)
+(0.0030 -0.0735 0.1815)
+(0.0060 -0.0735 0.1815)
+(-0.0060 -0.0705 0.1815)
+(-0.0030 -0.0705 0.1815)
+(0.0000 -0.0705 0.1815)
+(0.0030 -0.0705 0.1815)
+(0.0060 -0.0705 0.1815)
+(-0.0060 -0.0675 0.1815)
+(-0.0030 -0.0675 0.1815)
+(0.0000 -0.0675 0.1815)
+(0.0030 -0.0675 0.1815)
+(0.0060 -0.0675 0.1815)
+(-0.0060 -0.0645 0.1815)
+(-0.0030 -0.0645 0.1815)
+(0.0000 -0.0645 0.1815)
+(0.0030 -0.0645 0.1815)
+(0.0060 -0.0645 0.1815)
+(-0.0060 -0.0615 0.1815)
+(-0.0030 -0.0615 0.1815)
+(0.0000 -0.0615 0.1815)
+(0.0030 -0.0615 0.1815)
+(0.0060 -0.0615 0.1815)
+(-0.0060 -0.0585 0.1815)
+(-0.0030 -0.0585 0.1815)
+(0.0000 -0.0585 0.1815)
+(0.0030 -0.0585 0.1815)
+(0.0060 -0.0585 0.1815)
+(-0.0060 -0.0555 0.1815)
+(-0.0030 -0.0555 0.1815)
+(0.0000 -0.0555 0.1815)
+(0.0030 -0.0555 0.1815)
+(0.0060 -0.0555 0.1815)
+(-0.0060 -0.0525 0.1815)
+(-0.0030 -0.0525 0.1815)
+(0.0000 -0.0525 0.1815)
+(0.0030 -0.0525 0.1815)
+(0.0060 -0.0525 0.1815)
+(-0.0060 -0.0495 0.1815)
+(-0.0030 -0.0495 0.1815)
+(0.0000 -0.0495 0.1815)
+(0.0030 -0.0495 0.1815)
+(0.0060 -0.0495 0.1815)
+(-0.0060 -0.0465 0.1815)
+(-0.0030 -0.0465 0.1815)
+(0.0000 -0.0465 0.1815)
+(0.0030 -0.0465 0.1815)
+(0.0060 -0.0465 0.1815)
+(-0.0060 -0.0435 0.1815)
+(-0.0030 -0.0435 0.1815)
+(0.0000 -0.0435 0.1815)
+(0.0030 -0.0435 0.1815)
+(0.0060 -0.0435 0.1815)
+(-0.0060 -0.0405 0.1815)
+(-0.0030 -0.0405 0.1815)
+(0.0000 -0.0405 0.1815)
+(0.0030 -0.0405 0.1815)
+(0.0060 -0.0405 0.1815)
+(-0.0060 -0.0375 0.1815)
+(-0.0030 -0.0375 0.1815)
+(0.0000 -0.0375 0.1815)
+(0.0030 -0.0375 0.1815)
+(0.0060 -0.0375 0.1815)
+(-0.0060 -0.0345 0.1815)
+(-0.0030 -0.0345 0.1815)
+(0.0000 -0.0345 0.1815)
+(0.0030 -0.0345 0.1815)
+(0.0060 -0.0345 0.1815)
+(-0.0060 -0.0315 0.1815)
+(-0.0030 -0.0315 0.1815)
+(0.0000 -0.0315 0.1815)
+(0.0030 -0.0315 0.1815)
+(0.0060 -0.0315 0.1815)
+(-0.0060 -0.0285 0.1815)
+(-0.0030 -0.0285 0.1815)
+(0.0000 -0.0285 0.1815)
+(0.0030 -0.0285 0.1815)
+(0.0060 -0.0285 0.1815)
+(-0.0060 -0.0255 0.1815)
+(-0.0030 -0.0255 0.1815)
+(0.0000 -0.0255 0.1815)
+(0.0030 -0.0255 0.1815)
+(0.0060 -0.0255 0.1815)
+(-0.0060 -0.0225 0.1815)
+(-0.0030 -0.0225 0.1815)
+(0.0000 -0.0225 0.1815)
+(0.0030 -0.0225 0.1815)
+(0.0060 -0.0225 0.1815)
+(-0.0060 -0.0195 0.1815)
+(-0.0030 -0.0195 0.1815)
+(0.0000 -0.0195 0.1815)
+(0.0030 -0.0195 0.1815)
+(0.0060 -0.0195 0.1815)
+(-0.0060 -0.0165 0.1815)
+(-0.0030 -0.0165 0.1815)
+(0.0000 -0.0165 0.1815)
+(0.0030 -0.0165 0.1815)
+(0.0060 -0.0165 0.1815)
+(-0.0060 -0.0135 0.1815)
+(-0.0030 -0.0135 0.1815)
+(0.0000 -0.0135 0.1815)
+(0.0030 -0.0135 0.1815)
+(0.0060 -0.0135 0.1815)
+(-0.0060 -0.0105 0.1815)
+(-0.0030 -0.0105 0.1815)
+(0.0000 -0.0105 0.1815)
+(0.0030 -0.0105 0.1815)
+(0.0060 -0.0105 0.1815)
+(-0.0060 -0.0075 0.1815)
+(-0.0030 -0.0075 0.1815)
+(0.0000 -0.0075 0.1815)
+(0.0030 -0.0075 0.1815)
+(0.0060 -0.0075 0.1815)
+(-0.0060 -0.0045 0.1815)
+(-0.0030 -0.0045 0.1815)
+(0.0000 -0.0045 0.1815)
+(0.0030 -0.0045 0.1815)
+(0.0060 -0.0045 0.1815)
+(-0.0060 -0.0015 0.1815)
+(-0.0030 -0.0015 0.1815)
+(0.0000 -0.0015 0.1815)
+(0.0030 -0.0015 0.1815)
+(0.0060 -0.0015 0.1815)
+(-0.0060 0.0015 0.1815)
+(-0.0030 0.0015 0.1815)
+(0.0000 0.0015 0.1815)
+(0.0030 0.0015 0.1815)
+(0.0060 0.0015 0.1815)
+(-0.0060 0.0045 0.1815)
+(-0.0030 0.0045 0.1815)
+(0.0000 0.0045 0.1815)
+(0.0030 0.0045 0.1815)
+(0.0060 0.0045 0.1815)
+(-0.0060 0.0075 0.1815)
+(-0.0030 0.0075 0.1815)
+(0.0000 0.0075 0.1815)
+(0.0030 0.0075 0.1815)
+(0.0060 0.0075 0.1815)
+(-0.0060 0.0105 0.1815)
+(-0.0030 0.0105 0.1815)
+(0.0000 0.0105 0.1815)
+(0.0030 0.0105 0.1815)
+(0.0060 0.0105 0.1815)
+(-0.0060 0.0135 0.1815)
+(-0.0030 0.0135 0.1815)
+(0.0000 0.0135 0.1815)
+(0.0030 0.0135 0.1815)
+(0.0060 0.0135 0.1815)
+(-0.0060 0.0165 0.1815)
+(-0.0030 0.0165 0.1815)
+(0.0000 0.0165 0.1815)
+(0.0030 0.0165 0.1815)
+(0.0060 0.0165 0.1815)
+(-0.0060 0.0195 0.1815)
+(-0.0030 0.0195 0.1815)
+(0.0000 0.0195 0.1815)
+(0.0030 0.0195 0.1815)
+(0.0060 0.0195 0.1815)
+(-0.0060 0.0225 0.1815)
+(-0.0030 0.0225 0.1815)
+(0.0000 0.0225 0.1815)
+(0.0030 0.0225 0.1815)
+(0.0060 0.0225 0.1815)
+(-0.0060 0.0255 0.1815)
+(-0.0030 0.0255 0.1815)
+(0.0000 0.0255 0.1815)
+(0.0030 0.0255 0.1815)
+(0.0060 0.0255 0.1815)
+(-0.0060 0.0285 0.1815)
+(-0.0030 0.0285 0.1815)
+(0.0000 0.0285 0.1815)
+(0.0030 0.0285 0.1815)
+(0.0060 0.0285 0.1815)
+(-0.0060 0.0315 0.1815)
+(-0.0030 0.0315 0.1815)
+(0.0000 0.0315 0.1815)
+(0.0030 0.0315 0.1815)
+(0.0060 0.0315 0.1815)
+(-0.0060 0.0345 0.1815)
+(-0.0030 0.0345 0.1815)
+(0.0000 0.0345 0.1815)
+(0.0030 0.0345 0.1815)
+(0.0060 0.0345 0.1815)
+(-0.0060 0.0375 0.1815)
+(-0.0030 0.0375 0.1815)
+(0.0000 0.0375 0.1815)
+(0.0030 0.0375 0.1815)
+(0.0060 0.0375 0.1815)
+(-0.0060 0.0405 0.1815)
+(-0.0030 0.0405 0.1815)
+(0.0000 0.0405 0.1815)
+(0.0030 0.0405 0.1815)
+(0.0060 0.0405 0.1815)
+(-0.0060 0.0435 0.1815)
+(-0.0030 0.0435 0.1815)
+(0.0000 0.0435 0.1815)
+(0.0030 0.0435 0.1815)
+(0.0060 0.0435 0.1815)
+(-0.0060 0.0465 0.1815)
+(-0.0030 0.0465 0.1815)
+(0.0000 0.0465 0.1815)
+(0.0030 0.0465 0.1815)
+(0.0060 0.0465 0.1815)
+(-0.0060 0.0495 0.1815)
+(-0.0030 0.0495 0.1815)
+(0.0000 0.0495 0.1815)
+(0.0030 0.0495 0.1815)
+(0.0060 0.0495 0.1815)
+(-0.0060 0.0525 0.1815)
+(-0.0030 0.0525 0.1815)
+(0.0000 0.0525 0.1815)
+(0.0030 0.0525 0.1815)
+(0.0060 0.0525 0.1815)
+(-0.0060 0.0555 0.1815)
+(-0.0030 0.0555 0.1815)
+(0.0000 0.0555 0.1815)
+(0.0030 0.0555 0.1815)
+(0.0060 0.0555 0.1815)
+(-0.0060 0.0585 0.1815)
+(-0.0030 0.0585 0.1815)
+(0.0000 0.0585 0.1815)
+(0.0030 0.0585 0.1815)
+(0.0060 0.0585 0.1815)
+(-0.0060 0.0615 0.1815)
+(-0.0030 0.0615 0.1815)
+(0.0000 0.0615 0.1815)
+(0.0030 0.0615 0.1815)
+(0.0060 0.0615 0.1815)
+(-0.0060 0.0645 0.1815)
+(-0.0030 0.0645 0.1815)
+(0.0000 0.0645 0.1815)
+(0.0030 0.0645 0.1815)
+(0.0060 0.0645 0.1815)
+(-0.0060 0.0675 0.1815)
+(-0.0030 0.0675 0.1815)
+(0.0000 0.0675 0.1815)
+(0.0030 0.0675 0.1815)
+(0.0060 0.0675 0.1815)
+(-0.0060 0.0705 0.1815)
+(-0.0030 0.0705 0.1815)
+(0.0000 0.0705 0.1815)
+(0.0030 0.0705 0.1815)
+(0.0060 0.0705 0.1815)
+(-0.0060 0.0735 0.1815)
+(-0.0030 0.0735 0.1815)
+(0.0000 0.0735 0.1815)
+(0.0030 0.0735 0.1815)
+(0.0060 0.0735 0.1815)
+(-0.0060 -0.0735 0.1845)
+(-0.0030 -0.0735 0.1845)
+(0.0000 -0.0735 0.1845)
+(0.0030 -0.0735 0.1845)
+(0.0060 -0.0735 0.1845)
+(-0.0060 -0.0705 0.1845)
+(-0.0030 -0.0705 0.1845)
+(0.0000 -0.0705 0.1845)
+(0.0030 -0.0705 0.1845)
+(0.0060 -0.0705 0.1845)
+(-0.0060 -0.0675 0.1845)
+(-0.0030 -0.0675 0.1845)
+(0.0000 -0.0675 0.1845)
+(0.0030 -0.0675 0.1845)
+(0.0060 -0.0675 0.1845)
+(-0.0060 -0.0645 0.1845)
+(-0.0030 -0.0645 0.1845)
+(0.0000 -0.0645 0.1845)
+(0.0030 -0.0645 0.1845)
+(0.0060 -0.0645 0.1845)
+(-0.0060 -0.0615 0.1845)
+(-0.0030 -0.0615 0.1845)
+(0.0000 -0.0615 0.1845)
+(0.0030 -0.0615 0.1845)
+(0.0060 -0.0615 0.1845)
+(-0.0060 -0.0585 0.1845)
+(-0.0030 -0.0585 0.1845)
+(0.0000 -0.0585 0.1845)
+(0.0030 -0.0585 0.1845)
+(0.0060 -0.0585 0.1845)
+(-0.0060 -0.0555 0.1845)
+(-0.0030 -0.0555 0.1845)
+(0.0000 -0.0555 0.1845)
+(0.0030 -0.0555 0.1845)
+(0.0060 -0.0555 0.1845)
+(-0.0060 -0.0525 0.1845)
+(-0.0030 -0.0525 0.1845)
+(0.0000 -0.0525 0.1845)
+(0.0030 -0.0525 0.1845)
+(0.0060 -0.0525 0.1845)
+(-0.0060 -0.0495 0.1845)
+(-0.0030 -0.0495 0.1845)
+(0.0000 -0.0495 0.1845)
+(0.0030 -0.0495 0.1845)
+(0.0060 -0.0495 0.1845)
+(-0.0060 -0.0465 0.1845)
+(-0.0030 -0.0465 0.1845)
+(0.0000 -0.0465 0.1845)
+(0.0030 -0.0465 0.1845)
+(0.0060 -0.0465 0.1845)
+(-0.0060 -0.0435 0.1845)
+(-0.0030 -0.0435 0.1845)
+(0.0000 -0.0435 0.1845)
+(0.0030 -0.0435 0.1845)
+(0.0060 -0.0435 0.1845)
+(-0.0060 -0.0405 0.1845)
+(-0.0030 -0.0405 0.1845)
+(0.0000 -0.0405 0.1845)
+(0.0030 -0.0405 0.1845)
+(0.0060 -0.0405 0.1845)
+(-0.0060 -0.0375 0.1845)
+(-0.0030 -0.0375 0.1845)
+(0.0000 -0.0375 0.1845)
+(0.0030 -0.0375 0.1845)
+(0.0060 -0.0375 0.1845)
+(-0.0060 -0.0345 0.1845)
+(-0.0030 -0.0345 0.1845)
+(0.0000 -0.0345 0.1845)
+(0.0030 -0.0345 0.1845)
+(0.0060 -0.0345 0.1845)
+(-0.0060 -0.0315 0.1845)
+(-0.0030 -0.0315 0.1845)
+(0.0000 -0.0315 0.1845)
+(0.0030 -0.0315 0.1845)
+(0.0060 -0.0315 0.1845)
+(-0.0060 -0.0285 0.1845)
+(-0.0030 -0.0285 0.1845)
+(0.0000 -0.0285 0.1845)
+(0.0030 -0.0285 0.1845)
+(0.0060 -0.0285 0.1845)
+(-0.0060 -0.0255 0.1845)
+(-0.0030 -0.0255 0.1845)
+(0.0000 -0.0255 0.1845)
+(0.0030 -0.0255 0.1845)
+(0.0060 -0.0255 0.1845)
+(-0.0060 -0.0225 0.1845)
+(-0.0030 -0.0225 0.1845)
+(0.0000 -0.0225 0.1845)
+(0.0030 -0.0225 0.1845)
+(0.0060 -0.0225 0.1845)
+(-0.0060 -0.0195 0.1845)
+(-0.0030 -0.0195 0.1845)
+(0.0000 -0.0195 0.1845)
+(0.0030 -0.0195 0.1845)
+(0.0060 -0.0195 0.1845)
+(-0.0060 -0.0165 0.1845)
+(-0.0030 -0.0165 0.1845)
+(0.0000 -0.0165 0.1845)
+(0.0030 -0.0165 0.1845)
+(0.0060 -0.0165 0.1845)
+(-0.0060 -0.0135 0.1845)
+(-0.0030 -0.0135 0.1845)
+(0.0000 -0.0135 0.1845)
+(0.0030 -0.0135 0.1845)
+(0.0060 -0.0135 0.1845)
+(-0.0060 -0.0105 0.1845)
+(-0.0030 -0.0105 0.1845)
+(0.0000 -0.0105 0.1845)
+(0.0030 -0.0105 0.1845)
+(0.0060 -0.0105 0.1845)
+(-0.0060 -0.0075 0.1845)
+(-0.0030 -0.0075 0.1845)
+(0.0000 -0.0075 0.1845)
+(0.0030 -0.0075 0.1845)
+(0.0060 -0.0075 0.1845)
+(-0.0060 -0.0045 0.1845)
+(-0.0030 -0.0045 0.1845)
+(0.0000 -0.0045 0.1845)
+(0.0030 -0.0045 0.1845)
+(0.0060 -0.0045 0.1845)
+(-0.0060 -0.0015 0.1845)
+(-0.0030 -0.0015 0.1845)
+(0.0000 -0.0015 0.1845)
+(0.0030 -0.0015 0.1845)
+(0.0060 -0.0015 0.1845)
+(-0.0060 0.0015 0.1845)
+(-0.0030 0.0015 0.1845)
+(0.0000 0.0015 0.1845)
+(0.0030 0.0015 0.1845)
+(0.0060 0.0015 0.1845)
+(-0.0060 0.0045 0.1845)
+(-0.0030 0.0045 0.1845)
+(0.0000 0.0045 0.1845)
+(0.0030 0.0045 0.1845)
+(0.0060 0.0045 0.1845)
+(-0.0060 0.0075 0.1845)
+(-0.0030 0.0075 0.1845)
+(0.0000 0.0075 0.1845)
+(0.0030 0.0075 0.1845)
+(0.0060 0.0075 0.1845)
+(-0.0060 0.0105 0.1845)
+(-0.0030 0.0105 0.1845)
+(0.0000 0.0105 0.1845)
+(0.0030 0.0105 0.1845)
+(0.0060 0.0105 0.1845)
+(-0.0060 0.0135 0.1845)
+(-0.0030 0.0135 0.1845)
+(0.0000 0.0135 0.1845)
+(0.0030 0.0135 0.1845)
+(0.0060 0.0135 0.1845)
+(-0.0060 0.0165 0.1845)
+(-0.0030 0.0165 0.1845)
+(0.0000 0.0165 0.1845)
+(0.0030 0.0165 0.1845)
+(0.0060 0.0165 0.1845)
+(-0.0060 0.0195 0.1845)
+(-0.0030 0.0195 0.1845)
+(0.0000 0.0195 0.1845)
+(0.0030 0.0195 0.1845)
+(0.0060 0.0195 0.1845)
+(-0.0060 0.0225 0.1845)
+(-0.0030 0.0225 0.1845)
+(0.0000 0.0225 0.1845)
+(0.0030 0.0225 0.1845)
+(0.0060 0.0225 0.1845)
+(-0.0060 0.0255 0.1845)
+(-0.0030 0.0255 0.1845)
+(0.0000 0.0255 0.1845)
+(0.0030 0.0255 0.1845)
+(0.0060 0.0255 0.1845)
+(-0.0060 0.0285 0.1845)
+(-0.0030 0.0285 0.1845)
+(0.0000 0.0285 0.1845)
+(0.0030 0.0285 0.1845)
+(0.0060 0.0285 0.1845)
+(-0.0060 0.0315 0.1845)
+(-0.0030 0.0315 0.1845)
+(0.0000 0.0315 0.1845)
+(0.0030 0.0315 0.1845)
+(0.0060 0.0315 0.1845)
+(-0.0060 0.0345 0.1845)
+(-0.0030 0.0345 0.1845)
+(0.0000 0.0345 0.1845)
+(0.0030 0.0345 0.1845)
+(0.0060 0.0345 0.1845)
+(-0.0060 0.0375 0.1845)
+(-0.0030 0.0375 0.1845)
+(0.0000 0.0375 0.1845)
+(0.0030 0.0375 0.1845)
+(0.0060 0.0375 0.1845)
+(-0.0060 0.0405 0.1845)
+(-0.0030 0.0405 0.1845)
+(0.0000 0.0405 0.1845)
+(0.0030 0.0405 0.1845)
+(0.0060 0.0405 0.1845)
+(-0.0060 0.0435 0.1845)
+(-0.0030 0.0435 0.1845)
+(0.0000 0.0435 0.1845)
+(0.0030 0.0435 0.1845)
+(0.0060 0.0435 0.1845)
+(-0.0060 0.0465 0.1845)
+(-0.0030 0.0465 0.1845)
+(0.0000 0.0465 0.1845)
+(0.0030 0.0465 0.1845)
+(0.0060 0.0465 0.1845)
+(-0.0060 0.0495 0.1845)
+(-0.0030 0.0495 0.1845)
+(0.0000 0.0495 0.1845)
+(0.0030 0.0495 0.1845)
+(0.0060 0.0495 0.1845)
+(-0.0060 0.0525 0.1845)
+(-0.0030 0.0525 0.1845)
+(0.0000 0.0525 0.1845)
+(0.0030 0.0525 0.1845)
+(0.0060 0.0525 0.1845)
+(-0.0060 0.0555 0.1845)
+(-0.0030 0.0555 0.1845)
+(0.0000 0.0555 0.1845)
+(0.0030 0.0555 0.1845)
+(0.0060 0.0555 0.1845)
+(-0.0060 0.0585 0.1845)
+(-0.0030 0.0585 0.1845)
+(0.0000 0.0585 0.1845)
+(0.0030 0.0585 0.1845)
+(0.0060 0.0585 0.1845)
+(-0.0060 0.0615 0.1845)
+(-0.0030 0.0615 0.1845)
+(0.0000 0.0615 0.1845)
+(0.0030 0.0615 0.1845)
+(0.0060 0.0615 0.1845)
+(-0.0060 0.0645 0.1845)
+(-0.0030 0.0645 0.1845)
+(0.0000 0.0645 0.1845)
+(0.0030 0.0645 0.1845)
+(0.0060 0.0645 0.1845)
+(-0.0060 0.0675 0.1845)
+(-0.0030 0.0675 0.1845)
+(0.0000 0.0675 0.1845)
+(0.0030 0.0675 0.1845)
+(0.0060 0.0675 0.1845)
+(-0.0060 0.0705 0.1845)
+(-0.0030 0.0705 0.1845)
+(0.0000 0.0705 0.1845)
+(0.0030 0.0705 0.1845)
+(0.0060 0.0705 0.1845)
+(-0.0060 0.0735 0.1845)
+(-0.0030 0.0735 0.1845)
+(0.0000 0.0735 0.1845)
+(0.0030 0.0735 0.1845)
+(0.0060 0.0735 0.1845)
+(-0.0060 -0.0735 0.1875)
+(-0.0030 -0.0735 0.1875)
+(0.0000 -0.0735 0.1875)
+(0.0030 -0.0735 0.1875)
+(0.0060 -0.0735 0.1875)
+(-0.0060 -0.0705 0.1875)
+(-0.0030 -0.0705 0.1875)
+(0.0000 -0.0705 0.1875)
+(0.0030 -0.0705 0.1875)
+(0.0060 -0.0705 0.1875)
+(-0.0060 -0.0675 0.1875)
+(-0.0030 -0.0675 0.1875)
+(0.0000 -0.0675 0.1875)
+(0.0030 -0.0675 0.1875)
+(0.0060 -0.0675 0.1875)
+(-0.0060 -0.0645 0.1875)
+(-0.0030 -0.0645 0.1875)
+(0.0000 -0.0645 0.1875)
+(0.0030 -0.0645 0.1875)
+(0.0060 -0.0645 0.1875)
+(-0.0060 -0.0615 0.1875)
+(-0.0030 -0.0615 0.1875)
+(0.0000 -0.0615 0.1875)
+(0.0030 -0.0615 0.1875)
+(0.0060 -0.0615 0.1875)
+(-0.0060 -0.0585 0.1875)
+(-0.0030 -0.0585 0.1875)
+(0.0000 -0.0585 0.1875)
+(0.0030 -0.0585 0.1875)
+(0.0060 -0.0585 0.1875)
+(-0.0060 -0.0555 0.1875)
+(-0.0030 -0.0555 0.1875)
+(0.0000 -0.0555 0.1875)
+(0.0030 -0.0555 0.1875)
+(0.0060 -0.0555 0.1875)
+(-0.0060 -0.0525 0.1875)
+(-0.0030 -0.0525 0.1875)
+(0.0000 -0.0525 0.1875)
+(0.0030 -0.0525 0.1875)
+(0.0060 -0.0525 0.1875)
+(-0.0060 -0.0495 0.1875)
+(-0.0030 -0.0495 0.1875)
+(0.0000 -0.0495 0.1875)
+(0.0030 -0.0495 0.1875)
+(0.0060 -0.0495 0.1875)
+(-0.0060 -0.0465 0.1875)
+(-0.0030 -0.0465 0.1875)
+(0.0000 -0.0465 0.1875)
+(0.0030 -0.0465 0.1875)
+(0.0060 -0.0465 0.1875)
+(-0.0060 -0.0435 0.1875)
+(-0.0030 -0.0435 0.1875)
+(0.0000 -0.0435 0.1875)
+(0.0030 -0.0435 0.1875)
+(0.0060 -0.0435 0.1875)
+(-0.0060 -0.0405 0.1875)
+(-0.0030 -0.0405 0.1875)
+(0.0000 -0.0405 0.1875)
+(0.0030 -0.0405 0.1875)
+(0.0060 -0.0405 0.1875)
+(-0.0060 -0.0375 0.1875)
+(-0.0030 -0.0375 0.1875)
+(0.0000 -0.0375 0.1875)
+(0.0030 -0.0375 0.1875)
+(0.0060 -0.0375 0.1875)
+(-0.0060 -0.0345 0.1875)
+(-0.0030 -0.0345 0.1875)
+(0.0000 -0.0345 0.1875)
+(0.0030 -0.0345 0.1875)
+(0.0060 -0.0345 0.1875)
+(-0.0060 -0.0315 0.1875)
+(-0.0030 -0.0315 0.1875)
+(0.0000 -0.0315 0.1875)
+(0.0030 -0.0315 0.1875)
+(0.0060 -0.0315 0.1875)
+(-0.0060 -0.0285 0.1875)
+(-0.0030 -0.0285 0.1875)
+(0.0000 -0.0285 0.1875)
+(0.0030 -0.0285 0.1875)
+(0.0060 -0.0285 0.1875)
+(-0.0060 -0.0255 0.1875)
+(-0.0030 -0.0255 0.1875)
+(0.0000 -0.0255 0.1875)
+(0.0030 -0.0255 0.1875)
+(0.0060 -0.0255 0.1875)
+(-0.0060 -0.0225 0.1875)
+(-0.0030 -0.0225 0.1875)
+(0.0000 -0.0225 0.1875)
+(0.0030 -0.0225 0.1875)
+(0.0060 -0.0225 0.1875)
+(-0.0060 -0.0195 0.1875)
+(-0.0030 -0.0195 0.1875)
+(0.0000 -0.0195 0.1875)
+(0.0030 -0.0195 0.1875)
+(0.0060 -0.0195 0.1875)
+(-0.0060 -0.0165 0.1875)
+(-0.0030 -0.0165 0.1875)
+(0.0000 -0.0165 0.1875)
+(0.0030 -0.0165 0.1875)
+(0.0060 -0.0165 0.1875)
+(-0.0060 -0.0135 0.1875)
+(-0.0030 -0.0135 0.1875)
+(0.0000 -0.0135 0.1875)
+(0.0030 -0.0135 0.1875)
+(0.0060 -0.0135 0.1875)
+(-0.0060 -0.0105 0.1875)
+(-0.0030 -0.0105 0.1875)
+(0.0000 -0.0105 0.1875)
+(0.0030 -0.0105 0.1875)
+(0.0060 -0.0105 0.1875)
+(-0.0060 -0.0075 0.1875)
+(-0.0030 -0.0075 0.1875)
+(0.0000 -0.0075 0.1875)
+(0.0030 -0.0075 0.1875)
+(0.0060 -0.0075 0.1875)
+(-0.0060 -0.0045 0.1875)
+(-0.0030 -0.0045 0.1875)
+(0.0000 -0.0045 0.1875)
+(0.0030 -0.0045 0.1875)
+(0.0060 -0.0045 0.1875)
+(-0.0060 -0.0015 0.1875)
+(-0.0030 -0.0015 0.1875)
+(0.0000 -0.0015 0.1875)
+(0.0030 -0.0015 0.1875)
+(0.0060 -0.0015 0.1875)
+(-0.0060 0.0015 0.1875)
+(-0.0030 0.0015 0.1875)
+(0.0000 0.0015 0.1875)
+(0.0030 0.0015 0.1875)
+(0.0060 0.0015 0.1875)
+(-0.0060 0.0045 0.1875)
+(-0.0030 0.0045 0.1875)
+(0.0000 0.0045 0.1875)
+(0.0030 0.0045 0.1875)
+(0.0060 0.0045 0.1875)
+(-0.0060 0.0075 0.1875)
+(-0.0030 0.0075 0.1875)
+(0.0000 0.0075 0.1875)
+(0.0030 0.0075 0.1875)
+(0.0060 0.0075 0.1875)
+(-0.0060 0.0105 0.1875)
+(-0.0030 0.0105 0.1875)
+(0.0000 0.0105 0.1875)
+(0.0030 0.0105 0.1875)
+(0.0060 0.0105 0.1875)
+(-0.0060 0.0135 0.1875)
+(-0.0030 0.0135 0.1875)
+(0.0000 0.0135 0.1875)
+(0.0030 0.0135 0.1875)
+(0.0060 0.0135 0.1875)
+(-0.0060 0.0165 0.1875)
+(-0.0030 0.0165 0.1875)
+(0.0000 0.0165 0.1875)
+(0.0030 0.0165 0.1875)
+(0.0060 0.0165 0.1875)
+(-0.0060 0.0195 0.1875)
+(-0.0030 0.0195 0.1875)
+(0.0000 0.0195 0.1875)
+(0.0030 0.0195 0.1875)
+(0.0060 0.0195 0.1875)
+(-0.0060 0.0225 0.1875)
+(-0.0030 0.0225 0.1875)
+(0.0000 0.0225 0.1875)
+(0.0030 0.0225 0.1875)
+(0.0060 0.0225 0.1875)
+(-0.0060 0.0255 0.1875)
+(-0.0030 0.0255 0.1875)
+(0.0000 0.0255 0.1875)
+(0.0030 0.0255 0.1875)
+(0.0060 0.0255 0.1875)
+(-0.0060 0.0285 0.1875)
+(-0.0030 0.0285 0.1875)
+(0.0000 0.0285 0.1875)
+(0.0030 0.0285 0.1875)
+(0.0060 0.0285 0.1875)
+(-0.0060 0.0315 0.1875)
+(-0.0030 0.0315 0.1875)
+(0.0000 0.0315 0.1875)
+(0.0030 0.0315 0.1875)
+(0.0060 0.0315 0.1875)
+(-0.0060 0.0345 0.1875)
+(-0.0030 0.0345 0.1875)
+(0.0000 0.0345 0.1875)
+(0.0030 0.0345 0.1875)
+(0.0060 0.0345 0.1875)
+(-0.0060 0.0375 0.1875)
+(-0.0030 0.0375 0.1875)
+(0.0000 0.0375 0.1875)
+(0.0030 0.0375 0.1875)
+(0.0060 0.0375 0.1875)
+(-0.0060 0.0405 0.1875)
+(-0.0030 0.0405 0.1875)
+(0.0000 0.0405 0.1875)
+(0.0030 0.0405 0.1875)
+(0.0060 0.0405 0.1875)
+(-0.0060 0.0435 0.1875)
+(-0.0030 0.0435 0.1875)
+(0.0000 0.0435 0.1875)
+(0.0030 0.0435 0.1875)
+(0.0060 0.0435 0.1875)
+(-0.0060 0.0465 0.1875)
+(-0.0030 0.0465 0.1875)
+(0.0000 0.0465 0.1875)
+(0.0030 0.0465 0.1875)
+(0.0060 0.0465 0.1875)
+(-0.0060 0.0495 0.1875)
+(-0.0030 0.0495 0.1875)
+(0.0000 0.0495 0.1875)
+(0.0030 0.0495 0.1875)
+(0.0060 0.0495 0.1875)
+(-0.0060 0.0525 0.1875)
+(-0.0030 0.0525 0.1875)
+(0.0000 0.0525 0.1875)
+(0.0030 0.0525 0.1875)
+(0.0060 0.0525 0.1875)
+(-0.0060 0.0555 0.1875)
+(-0.0030 0.0555 0.1875)
+(0.0000 0.0555 0.1875)
+(0.0030 0.0555 0.1875)
+(0.0060 0.0555 0.1875)
+(-0.0060 0.0585 0.1875)
+(-0.0030 0.0585 0.1875)
+(0.0000 0.0585 0.1875)
+(0.0030 0.0585 0.1875)
+(0.0060 0.0585 0.1875)
+(-0.0060 0.0615 0.1875)
+(-0.0030 0.0615 0.1875)
+(0.0000 0.0615 0.1875)
+(0.0030 0.0615 0.1875)
+(0.0060 0.0615 0.1875)
+(-0.0060 0.0645 0.1875)
+(-0.0030 0.0645 0.1875)
+(0.0000 0.0645 0.1875)
+(0.0030 0.0645 0.1875)
+(0.0060 0.0645 0.1875)
+(-0.0060 0.0675 0.1875)
+(-0.0030 0.0675 0.1875)
+(0.0000 0.0675 0.1875)
+(0.0030 0.0675 0.1875)
+(0.0060 0.0675 0.1875)
+(-0.0060 0.0705 0.1875)
+(-0.0030 0.0705 0.1875)
+(0.0000 0.0705 0.1875)
+(0.0030 0.0705 0.1875)
+(0.0060 0.0705 0.1875)
+(-0.0060 0.0735 0.1875)
+(-0.0030 0.0735 0.1875)
+(0.0000 0.0735 0.1875)
+(0.0030 0.0735 0.1875)
+(0.0060 0.0735 0.1875)
+(-0.0060 -0.0735 0.1905)
+(-0.0030 -0.0735 0.1905)
+(0.0000 -0.0735 0.1905)
+(0.0030 -0.0735 0.1905)
+(0.0060 -0.0735 0.1905)
+(-0.0060 -0.0705 0.1905)
+(-0.0030 -0.0705 0.1905)
+(0.0000 -0.0705 0.1905)
+(0.0030 -0.0705 0.1905)
+(0.0060 -0.0705 0.1905)
+(-0.0060 -0.0675 0.1905)
+(-0.0030 -0.0675 0.1905)
+(0.0000 -0.0675 0.1905)
+(0.0030 -0.0675 0.1905)
+(0.0060 -0.0675 0.1905)
+(-0.0060 -0.0645 0.1905)
+(-0.0030 -0.0645 0.1905)
+(0.0000 -0.0645 0.1905)
+(0.0030 -0.0645 0.1905)
+(0.0060 -0.0645 0.1905)
+(-0.0060 -0.0615 0.1905)
+(-0.0030 -0.0615 0.1905)
+(0.0000 -0.0615 0.1905)
+(0.0030 -0.0615 0.1905)
+(0.0060 -0.0615 0.1905)
+(-0.0060 -0.0585 0.1905)
+(-0.0030 -0.0585 0.1905)
+(0.0000 -0.0585 0.1905)
+(0.0030 -0.0585 0.1905)
+(0.0060 -0.0585 0.1905)
+(-0.0060 -0.0555 0.1905)
+(-0.0030 -0.0555 0.1905)
+(0.0000 -0.0555 0.1905)
+(0.0030 -0.0555 0.1905)
+(0.0060 -0.0555 0.1905)
+(-0.0060 -0.0525 0.1905)
+(-0.0030 -0.0525 0.1905)
+(0.0000 -0.0525 0.1905)
+(0.0030 -0.0525 0.1905)
+(0.0060 -0.0525 0.1905)
+(-0.0060 -0.0495 0.1905)
+(-0.0030 -0.0495 0.1905)
+(0.0000 -0.0495 0.1905)
+(0.0030 -0.0495 0.1905)
+(0.0060 -0.0495 0.1905)
+(-0.0060 -0.0465 0.1905)
+(-0.0030 -0.0465 0.1905)
+(0.0000 -0.0465 0.1905)
+(0.0030 -0.0465 0.1905)
+(0.0060 -0.0465 0.1905)
+(-0.0060 -0.0435 0.1905)
+(-0.0030 -0.0435 0.1905)
+(0.0000 -0.0435 0.1905)
+(0.0030 -0.0435 0.1905)
+(0.0060 -0.0435 0.1905)
+(-0.0060 -0.0405 0.1905)
+(-0.0030 -0.0405 0.1905)
+(0.0000 -0.0405 0.1905)
+(0.0030 -0.0405 0.1905)
+(0.0060 -0.0405 0.1905)
+(-0.0060 -0.0375 0.1905)
+(-0.0030 -0.0375 0.1905)
+(0.0000 -0.0375 0.1905)
+(0.0030 -0.0375 0.1905)
+(0.0060 -0.0375 0.1905)
+(-0.0060 -0.0345 0.1905)
+(-0.0030 -0.0345 0.1905)
+(0.0000 -0.0345 0.1905)
+(0.0030 -0.0345 0.1905)
+(0.0060 -0.0345 0.1905)
+(-0.0060 -0.0315 0.1905)
+(-0.0030 -0.0315 0.1905)
+(0.0000 -0.0315 0.1905)
+(0.0030 -0.0315 0.1905)
+(0.0060 -0.0315 0.1905)
+(-0.0060 -0.0285 0.1905)
+(-0.0030 -0.0285 0.1905)
+(0.0000 -0.0285 0.1905)
+(0.0030 -0.0285 0.1905)
+(0.0060 -0.0285 0.1905)
+(-0.0060 -0.0255 0.1905)
+(-0.0030 -0.0255 0.1905)
+(0.0000 -0.0255 0.1905)
+(0.0030 -0.0255 0.1905)
+(0.0060 -0.0255 0.1905)
+(-0.0060 -0.0225 0.1905)
+(-0.0030 -0.0225 0.1905)
+(0.0000 -0.0225 0.1905)
+(0.0030 -0.0225 0.1905)
+(0.0060 -0.0225 0.1905)
+(-0.0060 -0.0195 0.1905)
+(-0.0030 -0.0195 0.1905)
+(0.0000 -0.0195 0.1905)
+(0.0030 -0.0195 0.1905)
+(0.0060 -0.0195 0.1905)
+(-0.0060 -0.0165 0.1905)
+(-0.0030 -0.0165 0.1905)
+(0.0000 -0.0165 0.1905)
+(0.0030 -0.0165 0.1905)
+(0.0060 -0.0165 0.1905)
+(-0.0060 -0.0135 0.1905)
+(-0.0030 -0.0135 0.1905)
+(0.0000 -0.0135 0.1905)
+(0.0030 -0.0135 0.1905)
+(0.0060 -0.0135 0.1905)
+(-0.0060 -0.0105 0.1905)
+(-0.0030 -0.0105 0.1905)
+(0.0000 -0.0105 0.1905)
+(0.0030 -0.0105 0.1905)
+(0.0060 -0.0105 0.1905)
+(-0.0060 -0.0075 0.1905)
+(-0.0030 -0.0075 0.1905)
+(0.0000 -0.0075 0.1905)
+(0.0030 -0.0075 0.1905)
+(0.0060 -0.0075 0.1905)
+(-0.0060 -0.0045 0.1905)
+(-0.0030 -0.0045 0.1905)
+(0.0000 -0.0045 0.1905)
+(0.0030 -0.0045 0.1905)
+(0.0060 -0.0045 0.1905)
+(-0.0060 -0.0015 0.1905)
+(-0.0030 -0.0015 0.1905)
+(0.0000 -0.0015 0.1905)
+(0.0030 -0.0015 0.1905)
+(0.0060 -0.0015 0.1905)
+(-0.0060 0.0015 0.1905)
+(-0.0030 0.0015 0.1905)
+(0.0000 0.0015 0.1905)
+(0.0030 0.0015 0.1905)
+(0.0060 0.0015 0.1905)
+(-0.0060 0.0045 0.1905)
+(-0.0030 0.0045 0.1905)
+(0.0000 0.0045 0.1905)
+(0.0030 0.0045 0.1905)
+(0.0060 0.0045 0.1905)
+(-0.0060 0.0075 0.1905)
+(-0.0030 0.0075 0.1905)
+(0.0000 0.0075 0.1905)
+(0.0030 0.0075 0.1905)
+(0.0060 0.0075 0.1905)
+(-0.0060 0.0105 0.1905)
+(-0.0030 0.0105 0.1905)
+(0.0000 0.0105 0.1905)
+(0.0030 0.0105 0.1905)
+(0.0060 0.0105 0.1905)
+(-0.0060 0.0135 0.1905)
+(-0.0030 0.0135 0.1905)
+(0.0000 0.0135 0.1905)
+(0.0030 0.0135 0.1905)
+(0.0060 0.0135 0.1905)
+(-0.0060 0.0165 0.1905)
+(-0.0030 0.0165 0.1905)
+(0.0000 0.0165 0.1905)
+(0.0030 0.0165 0.1905)
+(0.0060 0.0165 0.1905)
+(-0.0060 0.0195 0.1905)
+(-0.0030 0.0195 0.1905)
+(0.0000 0.0195 0.1905)
+(0.0030 0.0195 0.1905)
+(0.0060 0.0195 0.1905)
+(-0.0060 0.0225 0.1905)
+(-0.0030 0.0225 0.1905)
+(0.0000 0.0225 0.1905)
+(0.0030 0.0225 0.1905)
+(0.0060 0.0225 0.1905)
+(-0.0060 0.0255 0.1905)
+(-0.0030 0.0255 0.1905)
+(0.0000 0.0255 0.1905)
+(0.0030 0.0255 0.1905)
+(0.0060 0.0255 0.1905)
+(-0.0060 0.0285 0.1905)
+(-0.0030 0.0285 0.1905)
+(0.0000 0.0285 0.1905)
+(0.0030 0.0285 0.1905)
+(0.0060 0.0285 0.1905)
+(-0.0060 0.0315 0.1905)
+(-0.0030 0.0315 0.1905)
+(0.0000 0.0315 0.1905)
+(0.0030 0.0315 0.1905)
+(0.0060 0.0315 0.1905)
+(-0.0060 0.0345 0.1905)
+(-0.0030 0.0345 0.1905)
+(0.0000 0.0345 0.1905)
+(0.0030 0.0345 0.1905)
+(0.0060 0.0345 0.1905)
+(-0.0060 0.0375 0.1905)
+(-0.0030 0.0375 0.1905)
+(0.0000 0.0375 0.1905)
+(0.0030 0.0375 0.1905)
+(0.0060 0.0375 0.1905)
+(-0.0060 0.0405 0.1905)
+(-0.0030 0.0405 0.1905)
+(0.0000 0.0405 0.1905)
+(0.0030 0.0405 0.1905)
+(0.0060 0.0405 0.1905)
+(-0.0060 0.0435 0.1905)
+(-0.0030 0.0435 0.1905)
+(0.0000 0.0435 0.1905)
+(0.0030 0.0435 0.1905)
+(0.0060 0.0435 0.1905)
+(-0.0060 0.0465 0.1905)
+(-0.0030 0.0465 0.1905)
+(0.0000 0.0465 0.1905)
+(0.0030 0.0465 0.1905)
+(0.0060 0.0465 0.1905)
+(-0.0060 0.0495 0.1905)
+(-0.0030 0.0495 0.1905)
+(0.0000 0.0495 0.1905)
+(0.0030 0.0495 0.1905)
+(0.0060 0.0495 0.1905)
+(-0.0060 0.0525 0.1905)
+(-0.0030 0.0525 0.1905)
+(0.0000 0.0525 0.1905)
+(0.0030 0.0525 0.1905)
+(0.0060 0.0525 0.1905)
+(-0.0060 0.0555 0.1905)
+(-0.0030 0.0555 0.1905)
+(0.0000 0.0555 0.1905)
+(0.0030 0.0555 0.1905)
+(0.0060 0.0555 0.1905)
+(-0.0060 0.0585 0.1905)
+(-0.0030 0.0585 0.1905)
+(0.0000 0.0585 0.1905)
+(0.0030 0.0585 0.1905)
+(0.0060 0.0585 0.1905)
+(-0.0060 0.0615 0.1905)
+(-0.0030 0.0615 0.1905)
+(0.0000 0.0615 0.1905)
+(0.0030 0.0615 0.1905)
+(0.0060 0.0615 0.1905)
+(-0.0060 0.0645 0.1905)
+(-0.0030 0.0645 0.1905)
+(0.0000 0.0645 0.1905)
+(0.0030 0.0645 0.1905)
+(0.0060 0.0645 0.1905)
+(-0.0060 0.0675 0.1905)
+(-0.0030 0.0675 0.1905)
+(0.0000 0.0675 0.1905)
+(0.0030 0.0675 0.1905)
+(0.0060 0.0675 0.1905)
+(-0.0060 0.0705 0.1905)
+(-0.0030 0.0705 0.1905)
+(0.0000 0.0705 0.1905)
+(0.0030 0.0705 0.1905)
+(0.0060 0.0705 0.1905)
+(-0.0060 0.0735 0.1905)
+(-0.0030 0.0735 0.1905)
+(0.0000 0.0735 0.1905)
+(0.0030 0.0735 0.1905)
+(0.0060 0.0735 0.1905)
+(-0.0060 -0.0735 0.1935)
+(-0.0030 -0.0735 0.1935)
+(0.0000 -0.0735 0.1935)
+(0.0030 -0.0735 0.1935)
+(0.0060 -0.0735 0.1935)
+(-0.0060 -0.0705 0.1935)
+(-0.0030 -0.0705 0.1935)
+(0.0000 -0.0705 0.1935)
+(0.0030 -0.0705 0.1935)
+(0.0060 -0.0705 0.1935)
+(-0.0060 -0.0675 0.1935)
+(-0.0030 -0.0675 0.1935)
+(0.0000 -0.0675 0.1935)
+(0.0030 -0.0675 0.1935)
+(0.0060 -0.0675 0.1935)
+(-0.0060 -0.0645 0.1935)
+(-0.0030 -0.0645 0.1935)
+(0.0000 -0.0645 0.1935)
+(0.0030 -0.0645 0.1935)
+(0.0060 -0.0645 0.1935)
+(-0.0060 -0.0615 0.1935)
+(-0.0030 -0.0615 0.1935)
+(0.0000 -0.0615 0.1935)
+(0.0030 -0.0615 0.1935)
+(0.0060 -0.0615 0.1935)
+(-0.0060 -0.0585 0.1935)
+(-0.0030 -0.0585 0.1935)
+(0.0000 -0.0585 0.1935)
+(0.0030 -0.0585 0.1935)
+(0.0060 -0.0585 0.1935)
+(-0.0060 -0.0555 0.1935)
+(-0.0030 -0.0555 0.1935)
+(0.0000 -0.0555 0.1935)
+(0.0030 -0.0555 0.1935)
+(0.0060 -0.0555 0.1935)
+(-0.0060 -0.0525 0.1935)
+(-0.0030 -0.0525 0.1935)
+(0.0000 -0.0525 0.1935)
+(0.0030 -0.0525 0.1935)
+(0.0060 -0.0525 0.1935)
+(-0.0060 -0.0495 0.1935)
+(-0.0030 -0.0495 0.1935)
+(0.0000 -0.0495 0.1935)
+(0.0030 -0.0495 0.1935)
+(0.0060 -0.0495 0.1935)
+(-0.0060 -0.0465 0.1935)
+(-0.0030 -0.0465 0.1935)
+(0.0000 -0.0465 0.1935)
+(0.0030 -0.0465 0.1935)
+(0.0060 -0.0465 0.1935)
+(-0.0060 -0.0435 0.1935)
+(-0.0030 -0.0435 0.1935)
+(0.0000 -0.0435 0.1935)
+(0.0030 -0.0435 0.1935)
+(0.0060 -0.0435 0.1935)
+(-0.0060 -0.0405 0.1935)
+(-0.0030 -0.0405 0.1935)
+(0.0000 -0.0405 0.1935)
+(0.0030 -0.0405 0.1935)
+(0.0060 -0.0405 0.1935)
+(-0.0060 -0.0375 0.1935)
+(-0.0030 -0.0375 0.1935)
+(0.0000 -0.0375 0.1935)
+(0.0030 -0.0375 0.1935)
+(0.0060 -0.0375 0.1935)
+(-0.0060 -0.0345 0.1935)
+(-0.0030 -0.0345 0.1935)
+(0.0000 -0.0345 0.1935)
+(0.0030 -0.0345 0.1935)
+(0.0060 -0.0345 0.1935)
+(-0.0060 -0.0315 0.1935)
+(-0.0030 -0.0315 0.1935)
+(0.0000 -0.0315 0.1935)
+(0.0030 -0.0315 0.1935)
+(0.0060 -0.0315 0.1935)
+(-0.0060 -0.0285 0.1935)
+(-0.0030 -0.0285 0.1935)
+(0.0000 -0.0285 0.1935)
+(0.0030 -0.0285 0.1935)
+(0.0060 -0.0285 0.1935)
+(-0.0060 -0.0255 0.1935)
+(-0.0030 -0.0255 0.1935)
+(0.0000 -0.0255 0.1935)
+(0.0030 -0.0255 0.1935)
+(0.0060 -0.0255 0.1935)
+(-0.0060 -0.0225 0.1935)
+(-0.0030 -0.0225 0.1935)
+(0.0000 -0.0225 0.1935)
+(0.0030 -0.0225 0.1935)
+(0.0060 -0.0225 0.1935)
+(-0.0060 -0.0195 0.1935)
+(-0.0030 -0.0195 0.1935)
+(0.0000 -0.0195 0.1935)
+(0.0030 -0.0195 0.1935)
+(0.0060 -0.0195 0.1935)
+(-0.0060 -0.0165 0.1935)
+(-0.0030 -0.0165 0.1935)
+(0.0000 -0.0165 0.1935)
+(0.0030 -0.0165 0.1935)
+(0.0060 -0.0165 0.1935)
+(-0.0060 -0.0135 0.1935)
+(-0.0030 -0.0135 0.1935)
+(0.0000 -0.0135 0.1935)
+(0.0030 -0.0135 0.1935)
+(0.0060 -0.0135 0.1935)
+(-0.0060 -0.0105 0.1935)
+(-0.0030 -0.0105 0.1935)
+(0.0000 -0.0105 0.1935)
+(0.0030 -0.0105 0.1935)
+(0.0060 -0.0105 0.1935)
+(-0.0060 -0.0075 0.1935)
+(-0.0030 -0.0075 0.1935)
+(0.0000 -0.0075 0.1935)
+(0.0030 -0.0075 0.1935)
+(0.0060 -0.0075 0.1935)
+(-0.0060 -0.0045 0.1935)
+(-0.0030 -0.0045 0.1935)
+(0.0000 -0.0045 0.1935)
+(0.0030 -0.0045 0.1935)
+(0.0060 -0.0045 0.1935)
+(-0.0060 -0.0015 0.1935)
+(-0.0030 -0.0015 0.1935)
+(0.0000 -0.0015 0.1935)
+(0.0030 -0.0015 0.1935)
+(0.0060 -0.0015 0.1935)
+(-0.0060 0.0015 0.1935)
+(-0.0030 0.0015 0.1935)
+(0.0000 0.0015 0.1935)
+(0.0030 0.0015 0.1935)
+(0.0060 0.0015 0.1935)
+(-0.0060 0.0045 0.1935)
+(-0.0030 0.0045 0.1935)
+(0.0000 0.0045 0.1935)
+(0.0030 0.0045 0.1935)
+(0.0060 0.0045 0.1935)
+(-0.0060 0.0075 0.1935)
+(-0.0030 0.0075 0.1935)
+(0.0000 0.0075 0.1935)
+(0.0030 0.0075 0.1935)
+(0.0060 0.0075 0.1935)
+(-0.0060 0.0105 0.1935)
+(-0.0030 0.0105 0.1935)
+(0.0000 0.0105 0.1935)
+(0.0030 0.0105 0.1935)
+(0.0060 0.0105 0.1935)
+(-0.0060 0.0135 0.1935)
+(-0.0030 0.0135 0.1935)
+(0.0000 0.0135 0.1935)
+(0.0030 0.0135 0.1935)
+(0.0060 0.0135 0.1935)
+(-0.0060 0.0165 0.1935)
+(-0.0030 0.0165 0.1935)
+(0.0000 0.0165 0.1935)
+(0.0030 0.0165 0.1935)
+(0.0060 0.0165 0.1935)
+(-0.0060 0.0195 0.1935)
+(-0.0030 0.0195 0.1935)
+(0.0000 0.0195 0.1935)
+(0.0030 0.0195 0.1935)
+(0.0060 0.0195 0.1935)
+(-0.0060 0.0225 0.1935)
+(-0.0030 0.0225 0.1935)
+(0.0000 0.0225 0.1935)
+(0.0030 0.0225 0.1935)
+(0.0060 0.0225 0.1935)
+(-0.0060 0.0255 0.1935)
+(-0.0030 0.0255 0.1935)
+(0.0000 0.0255 0.1935)
+(0.0030 0.0255 0.1935)
+(0.0060 0.0255 0.1935)
+(-0.0060 0.0285 0.1935)
+(-0.0030 0.0285 0.1935)
+(0.0000 0.0285 0.1935)
+(0.0030 0.0285 0.1935)
+(0.0060 0.0285 0.1935)
+(-0.0060 0.0315 0.1935)
+(-0.0030 0.0315 0.1935)
+(0.0000 0.0315 0.1935)
+(0.0030 0.0315 0.1935)
+(0.0060 0.0315 0.1935)
+(-0.0060 0.0345 0.1935)
+(-0.0030 0.0345 0.1935)
+(0.0000 0.0345 0.1935)
+(0.0030 0.0345 0.1935)
+(0.0060 0.0345 0.1935)
+(-0.0060 0.0375 0.1935)
+(-0.0030 0.0375 0.1935)
+(0.0000 0.0375 0.1935)
+(0.0030 0.0375 0.1935)
+(0.0060 0.0375 0.1935)
+(-0.0060 0.0405 0.1935)
+(-0.0030 0.0405 0.1935)
+(0.0000 0.0405 0.1935)
+(0.0030 0.0405 0.1935)
+(0.0060 0.0405 0.1935)
+(-0.0060 0.0435 0.1935)
+(-0.0030 0.0435 0.1935)
+(0.0000 0.0435 0.1935)
+(0.0030 0.0435 0.1935)
+(0.0060 0.0435 0.1935)
+(-0.0060 0.0465 0.1935)
+(-0.0030 0.0465 0.1935)
+(0.0000 0.0465 0.1935)
+(0.0030 0.0465 0.1935)
+(0.0060 0.0465 0.1935)
+(-0.0060 0.0495 0.1935)
+(-0.0030 0.0495 0.1935)
+(0.0000 0.0495 0.1935)
+(0.0030 0.0495 0.1935)
+(0.0060 0.0495 0.1935)
+(-0.0060 0.0525 0.1935)
+(-0.0030 0.0525 0.1935)
+(0.0000 0.0525 0.1935)
+(0.0030 0.0525 0.1935)
+(0.0060 0.0525 0.1935)
+(-0.0060 0.0555 0.1935)
+(-0.0030 0.0555 0.1935)
+(0.0000 0.0555 0.1935)
+(0.0030 0.0555 0.1935)
+(0.0060 0.0555 0.1935)
+(-0.0060 0.0585 0.1935)
+(-0.0030 0.0585 0.1935)
+(0.0000 0.0585 0.1935)
+(0.0030 0.0585 0.1935)
+(0.0060 0.0585 0.1935)
+(-0.0060 0.0615 0.1935)
+(-0.0030 0.0615 0.1935)
+(0.0000 0.0615 0.1935)
+(0.0030 0.0615 0.1935)
+(0.0060 0.0615 0.1935)
+(-0.0060 0.0645 0.1935)
+(-0.0030 0.0645 0.1935)
+(0.0000 0.0645 0.1935)
+(0.0030 0.0645 0.1935)
+(0.0060 0.0645 0.1935)
+(-0.0060 0.0675 0.1935)
+(-0.0030 0.0675 0.1935)
+(0.0000 0.0675 0.1935)
+(0.0030 0.0675 0.1935)
+(0.0060 0.0675 0.1935)
+(-0.0060 0.0705 0.1935)
+(-0.0030 0.0705 0.1935)
+(0.0000 0.0705 0.1935)
+(0.0030 0.0705 0.1935)
+(0.0060 0.0705 0.1935)
+(-0.0060 0.0735 0.1935)
+(-0.0030 0.0735 0.1935)
+(0.0000 0.0735 0.1935)
+(0.0030 0.0735 0.1935)
+(0.0060 0.0735 0.1935)
+(-0.0060 -0.0735 0.1965)
+(-0.0030 -0.0735 0.1965)
+(0.0000 -0.0735 0.1965)
+(0.0030 -0.0735 0.1965)
+(0.0060 -0.0735 0.1965)
+(-0.0060 -0.0705 0.1965)
+(-0.0030 -0.0705 0.1965)
+(0.0000 -0.0705 0.1965)
+(0.0030 -0.0705 0.1965)
+(0.0060 -0.0705 0.1965)
+(-0.0060 -0.0675 0.1965)
+(-0.0030 -0.0675 0.1965)
+(0.0000 -0.0675 0.1965)
+(0.0030 -0.0675 0.1965)
+(0.0060 -0.0675 0.1965)
+(-0.0060 -0.0645 0.1965)
+(-0.0030 -0.0645 0.1965)
+(0.0000 -0.0645 0.1965)
+(0.0030 -0.0645 0.1965)
+(0.0060 -0.0645 0.1965)
+(-0.0060 -0.0615 0.1965)
+(-0.0030 -0.0615 0.1965)
+(0.0000 -0.0615 0.1965)
+(0.0030 -0.0615 0.1965)
+(0.0060 -0.0615 0.1965)
+(-0.0060 -0.0585 0.1965)
+(-0.0030 -0.0585 0.1965)
+(0.0000 -0.0585 0.1965)
+(0.0030 -0.0585 0.1965)
+(0.0060 -0.0585 0.1965)
+(-0.0060 -0.0555 0.1965)
+(-0.0030 -0.0555 0.1965)
+(0.0000 -0.0555 0.1965)
+(0.0030 -0.0555 0.1965)
+(0.0060 -0.0555 0.1965)
+(-0.0060 -0.0525 0.1965)
+(-0.0030 -0.0525 0.1965)
+(0.0000 -0.0525 0.1965)
+(0.0030 -0.0525 0.1965)
+(0.0060 -0.0525 0.1965)
+(-0.0060 -0.0495 0.1965)
+(-0.0030 -0.0495 0.1965)
+(0.0000 -0.0495 0.1965)
+(0.0030 -0.0495 0.1965)
+(0.0060 -0.0495 0.1965)
+(-0.0060 -0.0465 0.1965)
+(-0.0030 -0.0465 0.1965)
+(0.0000 -0.0465 0.1965)
+(0.0030 -0.0465 0.1965)
+(0.0060 -0.0465 0.1965)
+(-0.0060 -0.0435 0.1965)
+(-0.0030 -0.0435 0.1965)
+(0.0000 -0.0435 0.1965)
+(0.0030 -0.0435 0.1965)
+(0.0060 -0.0435 0.1965)
+(-0.0060 -0.0405 0.1965)
+(-0.0030 -0.0405 0.1965)
+(0.0000 -0.0405 0.1965)
+(0.0030 -0.0405 0.1965)
+(0.0060 -0.0405 0.1965)
+(-0.0060 -0.0375 0.1965)
+(-0.0030 -0.0375 0.1965)
+(0.0000 -0.0375 0.1965)
+(0.0030 -0.0375 0.1965)
+(0.0060 -0.0375 0.1965)
+(-0.0060 -0.0345 0.1965)
+(-0.0030 -0.0345 0.1965)
+(0.0000 -0.0345 0.1965)
+(0.0030 -0.0345 0.1965)
+(0.0060 -0.0345 0.1965)
+(-0.0060 -0.0315 0.1965)
+(-0.0030 -0.0315 0.1965)
+(0.0000 -0.0315 0.1965)
+(0.0030 -0.0315 0.1965)
+(0.0060 -0.0315 0.1965)
+(-0.0060 -0.0285 0.1965)
+(-0.0030 -0.0285 0.1965)
+(0.0000 -0.0285 0.1965)
+(0.0030 -0.0285 0.1965)
+(0.0060 -0.0285 0.1965)
+(-0.0060 -0.0255 0.1965)
+(-0.0030 -0.0255 0.1965)
+(0.0000 -0.0255 0.1965)
+(0.0030 -0.0255 0.1965)
+(0.0060 -0.0255 0.1965)
+(-0.0060 -0.0225 0.1965)
+(-0.0030 -0.0225 0.1965)
+(0.0000 -0.0225 0.1965)
+(0.0030 -0.0225 0.1965)
+(0.0060 -0.0225 0.1965)
+(-0.0060 -0.0195 0.1965)
+(-0.0030 -0.0195 0.1965)
+(0.0000 -0.0195 0.1965)
+(0.0030 -0.0195 0.1965)
+(0.0060 -0.0195 0.1965)
+(-0.0060 -0.0165 0.1965)
+(-0.0030 -0.0165 0.1965)
+(0.0000 -0.0165 0.1965)
+(0.0030 -0.0165 0.1965)
+(0.0060 -0.0165 0.1965)
+(-0.0060 -0.0135 0.1965)
+(-0.0030 -0.0135 0.1965)
+(0.0000 -0.0135 0.1965)
+(0.0030 -0.0135 0.1965)
+(0.0060 -0.0135 0.1965)
+(-0.0060 -0.0105 0.1965)
+(-0.0030 -0.0105 0.1965)
+(0.0000 -0.0105 0.1965)
+(0.0030 -0.0105 0.1965)
+(0.0060 -0.0105 0.1965)
+(-0.0060 -0.0075 0.1965)
+(-0.0030 -0.0075 0.1965)
+(0.0000 -0.0075 0.1965)
+(0.0030 -0.0075 0.1965)
+(0.0060 -0.0075 0.1965)
+(-0.0060 -0.0045 0.1965)
+(-0.0030 -0.0045 0.1965)
+(0.0000 -0.0045 0.1965)
+(0.0030 -0.0045 0.1965)
+(0.0060 -0.0045 0.1965)
+(-0.0060 -0.0015 0.1965)
+(-0.0030 -0.0015 0.1965)
+(0.0000 -0.0015 0.1965)
+(0.0030 -0.0015 0.1965)
+(0.0060 -0.0015 0.1965)
+(-0.0060 0.0015 0.1965)
+(-0.0030 0.0015 0.1965)
+(0.0000 0.0015 0.1965)
+(0.0030 0.0015 0.1965)
+(0.0060 0.0015 0.1965)
+(-0.0060 0.0045 0.1965)
+(-0.0030 0.0045 0.1965)
+(0.0000 0.0045 0.1965)
+(0.0030 0.0045 0.1965)
+(0.0060 0.0045 0.1965)
+(-0.0060 0.0075 0.1965)
+(-0.0030 0.0075 0.1965)
+(0.0000 0.0075 0.1965)
+(0.0030 0.0075 0.1965)
+(0.0060 0.0075 0.1965)
+(-0.0060 0.0105 0.1965)
+(-0.0030 0.0105 0.1965)
+(0.0000 0.0105 0.1965)
+(0.0030 0.0105 0.1965)
+(0.0060 0.0105 0.1965)
+(-0.0060 0.0135 0.1965)
+(-0.0030 0.0135 0.1965)
+(0.0000 0.0135 0.1965)
+(0.0030 0.0135 0.1965)
+(0.0060 0.0135 0.1965)
+(-0.0060 0.0165 0.1965)
+(-0.0030 0.0165 0.1965)
+(0.0000 0.0165 0.1965)
+(0.0030 0.0165 0.1965)
+(0.0060 0.0165 0.1965)
+(-0.0060 0.0195 0.1965)
+(-0.0030 0.0195 0.1965)
+(0.0000 0.0195 0.1965)
+(0.0030 0.0195 0.1965)
+(0.0060 0.0195 0.1965)
+(-0.0060 0.0225 0.1965)
+(-0.0030 0.0225 0.1965)
+(0.0000 0.0225 0.1965)
+(0.0030 0.0225 0.1965)
+(0.0060 0.0225 0.1965)
+(-0.0060 0.0255 0.1965)
+(-0.0030 0.0255 0.1965)
+(0.0000 0.0255 0.1965)
+(0.0030 0.0255 0.1965)
+(0.0060 0.0255 0.1965)
+(-0.0060 0.0285 0.1965)
+(-0.0030 0.0285 0.1965)
+(0.0000 0.0285 0.1965)
+(0.0030 0.0285 0.1965)
+(0.0060 0.0285 0.1965)
+(-0.0060 0.0315 0.1965)
+(-0.0030 0.0315 0.1965)
+(0.0000 0.0315 0.1965)
+(0.0030 0.0315 0.1965)
+(0.0060 0.0315 0.1965)
+(-0.0060 0.0345 0.1965)
+(-0.0030 0.0345 0.1965)
+(0.0000 0.0345 0.1965)
+(0.0030 0.0345 0.1965)
+(0.0060 0.0345 0.1965)
+(-0.0060 0.0375 0.1965)
+(-0.0030 0.0375 0.1965)
+(0.0000 0.0375 0.1965)
+(0.0030 0.0375 0.1965)
+(0.0060 0.0375 0.1965)
+(-0.0060 0.0405 0.1965)
+(-0.0030 0.0405 0.1965)
+(0.0000 0.0405 0.1965)
+(0.0030 0.0405 0.1965)
+(0.0060 0.0405 0.1965)
+(-0.0060 0.0435 0.1965)
+(-0.0030 0.0435 0.1965)
+(0.0000 0.0435 0.1965)
+(0.0030 0.0435 0.1965)
+(0.0060 0.0435 0.1965)
+(-0.0060 0.0465 0.1965)
+(-0.0030 0.0465 0.1965)
+(0.0000 0.0465 0.1965)
+(0.0030 0.0465 0.1965)
+(0.0060 0.0465 0.1965)
+(-0.0060 0.0495 0.1965)
+(-0.0030 0.0495 0.1965)
+(0.0000 0.0495 0.1965)
+(0.0030 0.0495 0.1965)
+(0.0060 0.0495 0.1965)
+(-0.0060 0.0525 0.1965)
+(-0.0030 0.0525 0.1965)
+(0.0000 0.0525 0.1965)
+(0.0030 0.0525 0.1965)
+(0.0060 0.0525 0.1965)
+(-0.0060 0.0555 0.1965)
+(-0.0030 0.0555 0.1965)
+(0.0000 0.0555 0.1965)
+(0.0030 0.0555 0.1965)
+(0.0060 0.0555 0.1965)
+(-0.0060 0.0585 0.1965)
+(-0.0030 0.0585 0.1965)
+(0.0000 0.0585 0.1965)
+(0.0030 0.0585 0.1965)
+(0.0060 0.0585 0.1965)
+(-0.0060 0.0615 0.1965)
+(-0.0030 0.0615 0.1965)
+(0.0000 0.0615 0.1965)
+(0.0030 0.0615 0.1965)
+(0.0060 0.0615 0.1965)
+(-0.0060 0.0645 0.1965)
+(-0.0030 0.0645 0.1965)
+(0.0000 0.0645 0.1965)
+(0.0030 0.0645 0.1965)
+(0.0060 0.0645 0.1965)
+(-0.0060 0.0675 0.1965)
+(-0.0030 0.0675 0.1965)
+(0.0000 0.0675 0.1965)
+(0.0030 0.0675 0.1965)
+(0.0060 0.0675 0.1965)
+(-0.0060 0.0705 0.1965)
+(-0.0030 0.0705 0.1965)
+(0.0000 0.0705 0.1965)
+(0.0030 0.0705 0.1965)
+(0.0060 0.0705 0.1965)
+(-0.0060 0.0735 0.1965)
+(-0.0030 0.0735 0.1965)
+(0.0000 0.0735 0.1965)
+(0.0030 0.0735 0.1965)
+(0.0060 0.0735 0.1965)
+(-0.0060 -0.0735 0.1995)
+(-0.0030 -0.0735 0.1995)
+(0.0000 -0.0735 0.1995)
+(0.0030 -0.0735 0.1995)
+(0.0060 -0.0735 0.1995)
+(-0.0060 -0.0705 0.1995)
+(-0.0030 -0.0705 0.1995)
+(0.0000 -0.0705 0.1995)
+(0.0030 -0.0705 0.1995)
+(0.0060 -0.0705 0.1995)
+(-0.0060 -0.0675 0.1995)
+(-0.0030 -0.0675 0.1995)
+(0.0000 -0.0675 0.1995)
+(0.0030 -0.0675 0.1995)
+(0.0060 -0.0675 0.1995)
+(-0.0060 -0.0645 0.1995)
+(-0.0030 -0.0645 0.1995)
+(0.0000 -0.0645 0.1995)
+(0.0030 -0.0645 0.1995)
+(0.0060 -0.0645 0.1995)
+(-0.0060 -0.0615 0.1995)
+(-0.0030 -0.0615 0.1995)
+(0.0000 -0.0615 0.1995)
+(0.0030 -0.0615 0.1995)
+(0.0060 -0.0615 0.1995)
+(-0.0060 -0.0585 0.1995)
+(-0.0030 -0.0585 0.1995)
+(0.0000 -0.0585 0.1995)
+(0.0030 -0.0585 0.1995)
+(0.0060 -0.0585 0.1995)
+(-0.0060 -0.0555 0.1995)
+(-0.0030 -0.0555 0.1995)
+(0.0000 -0.0555 0.1995)
+(0.0030 -0.0555 0.1995)
+(0.0060 -0.0555 0.1995)
+(-0.0060 -0.0525 0.1995)
+(-0.0030 -0.0525 0.1995)
+(0.0000 -0.0525 0.1995)
+(0.0030 -0.0525 0.1995)
+(0.0060 -0.0525 0.1995)
+(-0.0060 -0.0495 0.1995)
+(-0.0030 -0.0495 0.1995)
+(0.0000 -0.0495 0.1995)
+(0.0030 -0.0495 0.1995)
+(0.0060 -0.0495 0.1995)
+(-0.0060 -0.0465 0.1995)
+(-0.0030 -0.0465 0.1995)
+(0.0000 -0.0465 0.1995)
+(0.0030 -0.0465 0.1995)
+(0.0060 -0.0465 0.1995)
+(-0.0060 -0.0435 0.1995)
+(-0.0030 -0.0435 0.1995)
+(0.0000 -0.0435 0.1995)
+(0.0030 -0.0435 0.1995)
+(0.0060 -0.0435 0.1995)
+(-0.0060 -0.0405 0.1995)
+(-0.0030 -0.0405 0.1995)
+(0.0000 -0.0405 0.1995)
+(0.0030 -0.0405 0.1995)
+(0.0060 -0.0405 0.1995)
+(-0.0060 -0.0375 0.1995)
+(-0.0030 -0.0375 0.1995)
+(0.0000 -0.0375 0.1995)
+(0.0030 -0.0375 0.1995)
+(0.0060 -0.0375 0.1995)
+(-0.0060 -0.0345 0.1995)
+(-0.0030 -0.0345 0.1995)
+(0.0000 -0.0345 0.1995)
+(0.0030 -0.0345 0.1995)
+(0.0060 -0.0345 0.1995)
+(-0.0060 -0.0315 0.1995)
+(-0.0030 -0.0315 0.1995)
+(0.0000 -0.0315 0.1995)
+(0.0030 -0.0315 0.1995)
+(0.0060 -0.0315 0.1995)
+(-0.0060 -0.0285 0.1995)
+(-0.0030 -0.0285 0.1995)
+(0.0000 -0.0285 0.1995)
+(0.0030 -0.0285 0.1995)
+(0.0060 -0.0285 0.1995)
+(-0.0060 -0.0255 0.1995)
+(-0.0030 -0.0255 0.1995)
+(0.0000 -0.0255 0.1995)
+(0.0030 -0.0255 0.1995)
+(0.0060 -0.0255 0.1995)
+(-0.0060 -0.0225 0.1995)
+(-0.0030 -0.0225 0.1995)
+(0.0000 -0.0225 0.1995)
+(0.0030 -0.0225 0.1995)
+(0.0060 -0.0225 0.1995)
+(-0.0060 -0.0195 0.1995)
+(-0.0030 -0.0195 0.1995)
+(0.0000 -0.0195 0.1995)
+(0.0030 -0.0195 0.1995)
+(0.0060 -0.0195 0.1995)
+(-0.0060 -0.0165 0.1995)
+(-0.0030 -0.0165 0.1995)
+(0.0000 -0.0165 0.1995)
+(0.0030 -0.0165 0.1995)
+(0.0060 -0.0165 0.1995)
+(-0.0060 -0.0135 0.1995)
+(-0.0030 -0.0135 0.1995)
+(0.0000 -0.0135 0.1995)
+(0.0030 -0.0135 0.1995)
+(0.0060 -0.0135 0.1995)
+(-0.0060 -0.0105 0.1995)
+(-0.0030 -0.0105 0.1995)
+(0.0000 -0.0105 0.1995)
+(0.0030 -0.0105 0.1995)
+(0.0060 -0.0105 0.1995)
+(-0.0060 -0.0075 0.1995)
+(-0.0030 -0.0075 0.1995)
+(0.0000 -0.0075 0.1995)
+(0.0030 -0.0075 0.1995)
+(0.0060 -0.0075 0.1995)
+(-0.0060 -0.0045 0.1995)
+(-0.0030 -0.0045 0.1995)
+(0.0000 -0.0045 0.1995)
+(0.0030 -0.0045 0.1995)
+(0.0060 -0.0045 0.1995)
+(-0.0060 -0.0015 0.1995)
+(-0.0030 -0.0015 0.1995)
+(0.0000 -0.0015 0.1995)
+(0.0030 -0.0015 0.1995)
+(0.0060 -0.0015 0.1995)
+(-0.0060 0.0015 0.1995)
+(-0.0030 0.0015 0.1995)
+(0.0000 0.0015 0.1995)
+(0.0030 0.0015 0.1995)
+(0.0060 0.0015 0.1995)
+(-0.0060 0.0045 0.1995)
+(-0.0030 0.0045 0.1995)
+(0.0000 0.0045 0.1995)
+(0.0030 0.0045 0.1995)
+(0.0060 0.0045 0.1995)
+(-0.0060 0.0075 0.1995)
+(-0.0030 0.0075 0.1995)
+(0.0000 0.0075 0.1995)
+(0.0030 0.0075 0.1995)
+(0.0060 0.0075 0.1995)
+(-0.0060 0.0105 0.1995)
+(-0.0030 0.0105 0.1995)
+(0.0000 0.0105 0.1995)
+(0.0030 0.0105 0.1995)
+(0.0060 0.0105 0.1995)
+(-0.0060 0.0135 0.1995)
+(-0.0030 0.0135 0.1995)
+(0.0000 0.0135 0.1995)
+(0.0030 0.0135 0.1995)
+(0.0060 0.0135 0.1995)
+(-0.0060 0.0165 0.1995)
+(-0.0030 0.0165 0.1995)
+(0.0000 0.0165 0.1995)
+(0.0030 0.0165 0.1995)
+(0.0060 0.0165 0.1995)
+(-0.0060 0.0195 0.1995)
+(-0.0030 0.0195 0.1995)
+(0.0000 0.0195 0.1995)
+(0.0030 0.0195 0.1995)
+(0.0060 0.0195 0.1995)
+(-0.0060 0.0225 0.1995)
+(-0.0030 0.0225 0.1995)
+(0.0000 0.0225 0.1995)
+(0.0030 0.0225 0.1995)
+(0.0060 0.0225 0.1995)
+(-0.0060 0.0255 0.1995)
+(-0.0030 0.0255 0.1995)
+(0.0000 0.0255 0.1995)
+(0.0030 0.0255 0.1995)
+(0.0060 0.0255 0.1995)
+(-0.0060 0.0285 0.1995)
+(-0.0030 0.0285 0.1995)
+(0.0000 0.0285 0.1995)
+(0.0030 0.0285 0.1995)
+(0.0060 0.0285 0.1995)
+(-0.0060 0.0315 0.1995)
+(-0.0030 0.0315 0.1995)
+(0.0000 0.0315 0.1995)
+(0.0030 0.0315 0.1995)
+(0.0060 0.0315 0.1995)
+(-0.0060 0.0345 0.1995)
+(-0.0030 0.0345 0.1995)
+(0.0000 0.0345 0.1995)
+(0.0030 0.0345 0.1995)
+(0.0060 0.0345 0.1995)
+(-0.0060 0.0375 0.1995)
+(-0.0030 0.0375 0.1995)
+(0.0000 0.0375 0.1995)
+(0.0030 0.0375 0.1995)
+(0.0060 0.0375 0.1995)
+(-0.0060 0.0405 0.1995)
+(-0.0030 0.0405 0.1995)
+(0.0000 0.0405 0.1995)
+(0.0030 0.0405 0.1995)
+(0.0060 0.0405 0.1995)
+(-0.0060 0.0435 0.1995)
+(-0.0030 0.0435 0.1995)
+(0.0000 0.0435 0.1995)
+(0.0030 0.0435 0.1995)
+(0.0060 0.0435 0.1995)
+(-0.0060 0.0465 0.1995)
+(-0.0030 0.0465 0.1995)
+(0.0000 0.0465 0.1995)
+(0.0030 0.0465 0.1995)
+(0.0060 0.0465 0.1995)
+(-0.0060 0.0495 0.1995)
+(-0.0030 0.0495 0.1995)
+(0.0000 0.0495 0.1995)
+(0.0030 0.0495 0.1995)
+(0.0060 0.0495 0.1995)
+(-0.0060 0.0525 0.1995)
+(-0.0030 0.0525 0.1995)
+(0.0000 0.0525 0.1995)
+(0.0030 0.0525 0.1995)
+(0.0060 0.0525 0.1995)
+(-0.0060 0.0555 0.1995)
+(-0.0030 0.0555 0.1995)
+(0.0000 0.0555 0.1995)
+(0.0030 0.0555 0.1995)
+(0.0060 0.0555 0.1995)
+(-0.0060 0.0585 0.1995)
+(-0.0030 0.0585 0.1995)
+(0.0000 0.0585 0.1995)
+(0.0030 0.0585 0.1995)
+(0.0060 0.0585 0.1995)
+(-0.0060 0.0615 0.1995)
+(-0.0030 0.0615 0.1995)
+(0.0000 0.0615 0.1995)
+(0.0030 0.0615 0.1995)
+(0.0060 0.0615 0.1995)
+(-0.0060 0.0645 0.1995)
+(-0.0030 0.0645 0.1995)
+(0.0000 0.0645 0.1995)
+(0.0030 0.0645 0.1995)
+(0.0060 0.0645 0.1995)
+(-0.0060 0.0675 0.1995)
+(-0.0030 0.0675 0.1995)
+(0.0000 0.0675 0.1995)
+(0.0030 0.0675 0.1995)
+(0.0060 0.0675 0.1995)
+(-0.0060 0.0705 0.1995)
+(-0.0030 0.0705 0.1995)
+(0.0000 0.0705 0.1995)
+(0.0030 0.0705 0.1995)
+(0.0060 0.0705 0.1995)
+(-0.0060 0.0735 0.1995)
+(-0.0030 0.0735 0.1995)
+(0.0000 0.0735 0.1995)
+(0.0030 0.0735 0.1995)
+(0.0060 0.0735 0.1995)
+(-0.0060 -0.0735 0.2025)
+(-0.0030 -0.0735 0.2025)
+(0.0000 -0.0735 0.2025)
+(0.0030 -0.0735 0.2025)
+(0.0060 -0.0735 0.2025)
+(-0.0060 -0.0705 0.2025)
+(-0.0030 -0.0705 0.2025)
+(0.0000 -0.0705 0.2025)
+(0.0030 -0.0705 0.2025)
+(0.0060 -0.0705 0.2025)
+(-0.0060 -0.0675 0.2025)
+(-0.0030 -0.0675 0.2025)
+(0.0000 -0.0675 0.2025)
+(0.0030 -0.0675 0.2025)
+(0.0060 -0.0675 0.2025)
+(-0.0060 -0.0645 0.2025)
+(-0.0030 -0.0645 0.2025)
+(0.0000 -0.0645 0.2025)
+(0.0030 -0.0645 0.2025)
+(0.0060 -0.0645 0.2025)
+(-0.0060 -0.0615 0.2025)
+(-0.0030 -0.0615 0.2025)
+(0.0000 -0.0615 0.2025)
+(0.0030 -0.0615 0.2025)
+(0.0060 -0.0615 0.2025)
+(-0.0060 -0.0585 0.2025)
+(-0.0030 -0.0585 0.2025)
+(0.0000 -0.0585 0.2025)
+(0.0030 -0.0585 0.2025)
+(0.0060 -0.0585 0.2025)
+(-0.0060 -0.0555 0.2025)
+(-0.0030 -0.0555 0.2025)
+(0.0000 -0.0555 0.2025)
+(0.0030 -0.0555 0.2025)
+(0.0060 -0.0555 0.2025)
+(-0.0060 -0.0525 0.2025)
+(-0.0030 -0.0525 0.2025)
+(0.0000 -0.0525 0.2025)
+(0.0030 -0.0525 0.2025)
+(0.0060 -0.0525 0.2025)
+(-0.0060 -0.0495 0.2025)
+(-0.0030 -0.0495 0.2025)
+(0.0000 -0.0495 0.2025)
+(0.0030 -0.0495 0.2025)
+(0.0060 -0.0495 0.2025)
+(-0.0060 -0.0465 0.2025)
+(-0.0030 -0.0465 0.2025)
+(0.0000 -0.0465 0.2025)
+(0.0030 -0.0465 0.2025)
+(0.0060 -0.0465 0.2025)
+(-0.0060 -0.0435 0.2025)
+(-0.0030 -0.0435 0.2025)
+(0.0000 -0.0435 0.2025)
+(0.0030 -0.0435 0.2025)
+(0.0060 -0.0435 0.2025)
+(-0.0060 -0.0405 0.2025)
+(-0.0030 -0.0405 0.2025)
+(0.0000 -0.0405 0.2025)
+(0.0030 -0.0405 0.2025)
+(0.0060 -0.0405 0.2025)
+(-0.0060 -0.0375 0.2025)
+(-0.0030 -0.0375 0.2025)
+(0.0000 -0.0375 0.2025)
+(0.0030 -0.0375 0.2025)
+(0.0060 -0.0375 0.2025)
+(-0.0060 -0.0345 0.2025)
+(-0.0030 -0.0345 0.2025)
+(0.0000 -0.0345 0.2025)
+(0.0030 -0.0345 0.2025)
+(0.0060 -0.0345 0.2025)
+(-0.0060 -0.0315 0.2025)
+(-0.0030 -0.0315 0.2025)
+(0.0000 -0.0315 0.2025)
+(0.0030 -0.0315 0.2025)
+(0.0060 -0.0315 0.2025)
+(-0.0060 -0.0285 0.2025)
+(-0.0030 -0.0285 0.2025)
+(0.0000 -0.0285 0.2025)
+(0.0030 -0.0285 0.2025)
+(0.0060 -0.0285 0.2025)
+(-0.0060 -0.0255 0.2025)
+(-0.0030 -0.0255 0.2025)
+(0.0000 -0.0255 0.2025)
+(0.0030 -0.0255 0.2025)
+(0.0060 -0.0255 0.2025)
+(-0.0060 -0.0225 0.2025)
+(-0.0030 -0.0225 0.2025)
+(0.0000 -0.0225 0.2025)
+(0.0030 -0.0225 0.2025)
+(0.0060 -0.0225 0.2025)
+(-0.0060 -0.0195 0.2025)
+(-0.0030 -0.0195 0.2025)
+(0.0000 -0.0195 0.2025)
+(0.0030 -0.0195 0.2025)
+(0.0060 -0.0195 0.2025)
+(-0.0060 -0.0165 0.2025)
+(-0.0030 -0.0165 0.2025)
+(0.0000 -0.0165 0.2025)
+(0.0030 -0.0165 0.2025)
+(0.0060 -0.0165 0.2025)
+(-0.0060 -0.0135 0.2025)
+(-0.0030 -0.0135 0.2025)
+(0.0000 -0.0135 0.2025)
+(0.0030 -0.0135 0.2025)
+(0.0060 -0.0135 0.2025)
+(-0.0060 -0.0105 0.2025)
+(-0.0030 -0.0105 0.2025)
+(0.0000 -0.0105 0.2025)
+(0.0030 -0.0105 0.2025)
+(0.0060 -0.0105 0.2025)
+(-0.0060 -0.0075 0.2025)
+(-0.0030 -0.0075 0.2025)
+(0.0000 -0.0075 0.2025)
+(0.0030 -0.0075 0.2025)
+(0.0060 -0.0075 0.2025)
+(-0.0060 -0.0045 0.2025)
+(-0.0030 -0.0045 0.2025)
+(0.0000 -0.0045 0.2025)
+(0.0030 -0.0045 0.2025)
+(0.0060 -0.0045 0.2025)
+(-0.0060 -0.0015 0.2025)
+(-0.0030 -0.0015 0.2025)
+(0.0000 -0.0015 0.2025)
+(0.0030 -0.0015 0.2025)
+(0.0060 -0.0015 0.2025)
+(-0.0060 0.0015 0.2025)
+(-0.0030 0.0015 0.2025)
+(0.0000 0.0015 0.2025)
+(0.0030 0.0015 0.2025)
+(0.0060 0.0015 0.2025)
+(-0.0060 0.0045 0.2025)
+(-0.0030 0.0045 0.2025)
+(0.0000 0.0045 0.2025)
+(0.0030 0.0045 0.2025)
+(0.0060 0.0045 0.2025)
+(-0.0060 0.0075 0.2025)
+(-0.0030 0.0075 0.2025)
+(0.0000 0.0075 0.2025)
+(0.0030 0.0075 0.2025)
+(0.0060 0.0075 0.2025)
+(-0.0060 0.0105 0.2025)
+(-0.0030 0.0105 0.2025)
+(0.0000 0.0105 0.2025)
+(0.0030 0.0105 0.2025)
+(0.0060 0.0105 0.2025)
+(-0.0060 0.0135 0.2025)
+(-0.0030 0.0135 0.2025)
+(0.0000 0.0135 0.2025)
+(0.0030 0.0135 0.2025)
+(0.0060 0.0135 0.2025)
+(-0.0060 0.0165 0.2025)
+(-0.0030 0.0165 0.2025)
+(0.0000 0.0165 0.2025)
+(0.0030 0.0165 0.2025)
+(0.0060 0.0165 0.2025)
+(-0.0060 0.0195 0.2025)
+(-0.0030 0.0195 0.2025)
+(0.0000 0.0195 0.2025)
+(0.0030 0.0195 0.2025)
+(0.0060 0.0195 0.2025)
+(-0.0060 0.0225 0.2025)
+(-0.0030 0.0225 0.2025)
+(0.0000 0.0225 0.2025)
+(0.0030 0.0225 0.2025)
+(0.0060 0.0225 0.2025)
+(-0.0060 0.0255 0.2025)
+(-0.0030 0.0255 0.2025)
+(0.0000 0.0255 0.2025)
+(0.0030 0.0255 0.2025)
+(0.0060 0.0255 0.2025)
+(-0.0060 0.0285 0.2025)
+(-0.0030 0.0285 0.2025)
+(0.0000 0.0285 0.2025)
+(0.0030 0.0285 0.2025)
+(0.0060 0.0285 0.2025)
+(-0.0060 0.0315 0.2025)
+(-0.0030 0.0315 0.2025)
+(0.0000 0.0315 0.2025)
+(0.0030 0.0315 0.2025)
+(0.0060 0.0315 0.2025)
+(-0.0060 0.0345 0.2025)
+(-0.0030 0.0345 0.2025)
+(0.0000 0.0345 0.2025)
+(0.0030 0.0345 0.2025)
+(0.0060 0.0345 0.2025)
+(-0.0060 0.0375 0.2025)
+(-0.0030 0.0375 0.2025)
+(0.0000 0.0375 0.2025)
+(0.0030 0.0375 0.2025)
+(0.0060 0.0375 0.2025)
+(-0.0060 0.0405 0.2025)
+(-0.0030 0.0405 0.2025)
+(0.0000 0.0405 0.2025)
+(0.0030 0.0405 0.2025)
+(0.0060 0.0405 0.2025)
+(-0.0060 0.0435 0.2025)
+(-0.0030 0.0435 0.2025)
+(0.0000 0.0435 0.2025)
+(0.0030 0.0435 0.2025)
+(0.0060 0.0435 0.2025)
+(-0.0060 0.0465 0.2025)
+(-0.0030 0.0465 0.2025)
+(0.0000 0.0465 0.2025)
+(0.0030 0.0465 0.2025)
+(0.0060 0.0465 0.2025)
+(-0.0060 0.0495 0.2025)
+(-0.0030 0.0495 0.2025)
+(0.0000 0.0495 0.2025)
+(0.0030 0.0495 0.2025)
+(0.0060 0.0495 0.2025)
+(-0.0060 0.0525 0.2025)
+(-0.0030 0.0525 0.2025)
+(0.0000 0.0525 0.2025)
+(0.0030 0.0525 0.2025)
+(0.0060 0.0525 0.2025)
+(-0.0060 0.0555 0.2025)
+(-0.0030 0.0555 0.2025)
+(0.0000 0.0555 0.2025)
+(0.0030 0.0555 0.2025)
+(0.0060 0.0555 0.2025)
+(-0.0060 0.0585 0.2025)
+(-0.0030 0.0585 0.2025)
+(0.0000 0.0585 0.2025)
+(0.0030 0.0585 0.2025)
+(0.0060 0.0585 0.2025)
+(-0.0060 0.0615 0.2025)
+(-0.0030 0.0615 0.2025)
+(0.0000 0.0615 0.2025)
+(0.0030 0.0615 0.2025)
+(0.0060 0.0615 0.2025)
+(-0.0060 0.0645 0.2025)
+(-0.0030 0.0645 0.2025)
+(0.0000 0.0645 0.2025)
+(0.0030 0.0645 0.2025)
+(0.0060 0.0645 0.2025)
+(-0.0060 0.0675 0.2025)
+(-0.0030 0.0675 0.2025)
+(0.0000 0.0675 0.2025)
+(0.0030 0.0675 0.2025)
+(0.0060 0.0675 0.2025)
+(-0.0060 0.0705 0.2025)
+(-0.0030 0.0705 0.2025)
+(0.0000 0.0705 0.2025)
+(0.0030 0.0705 0.2025)
+(0.0060 0.0705 0.2025)
+(-0.0060 0.0735 0.2025)
+(-0.0030 0.0735 0.2025)
+(0.0000 0.0735 0.2025)
+(0.0030 0.0735 0.2025)
+(0.0060 0.0735 0.2025)
+(-0.0060 -0.0735 0.2055)
+(-0.0030 -0.0735 0.2055)
+(0.0000 -0.0735 0.2055)
+(0.0030 -0.0735 0.2055)
+(0.0060 -0.0735 0.2055)
+(-0.0060 -0.0705 0.2055)
+(-0.0030 -0.0705 0.2055)
+(0.0000 -0.0705 0.2055)
+(0.0030 -0.0705 0.2055)
+(0.0060 -0.0705 0.2055)
+(-0.0060 -0.0675 0.2055)
+(-0.0030 -0.0675 0.2055)
+(0.0000 -0.0675 0.2055)
+(0.0030 -0.0675 0.2055)
+(0.0060 -0.0675 0.2055)
+(-0.0060 -0.0645 0.2055)
+(-0.0030 -0.0645 0.2055)
+(0.0000 -0.0645 0.2055)
+(0.0030 -0.0645 0.2055)
+(0.0060 -0.0645 0.2055)
+(-0.0060 -0.0615 0.2055)
+(-0.0030 -0.0615 0.2055)
+(0.0000 -0.0615 0.2055)
+(0.0030 -0.0615 0.2055)
+(0.0060 -0.0615 0.2055)
+(-0.0060 -0.0585 0.2055)
+(-0.0030 -0.0585 0.2055)
+(0.0000 -0.0585 0.2055)
+(0.0030 -0.0585 0.2055)
+(0.0060 -0.0585 0.2055)
+(-0.0060 -0.0555 0.2055)
+(-0.0030 -0.0555 0.2055)
+(0.0000 -0.0555 0.2055)
+(0.0030 -0.0555 0.2055)
+(0.0060 -0.0555 0.2055)
+(-0.0060 -0.0525 0.2055)
+(-0.0030 -0.0525 0.2055)
+(0.0000 -0.0525 0.2055)
+(0.0030 -0.0525 0.2055)
+(0.0060 -0.0525 0.2055)
+(-0.0060 -0.0495 0.2055)
+(-0.0030 -0.0495 0.2055)
+(0.0000 -0.0495 0.2055)
+(0.0030 -0.0495 0.2055)
+(0.0060 -0.0495 0.2055)
+(-0.0060 -0.0465 0.2055)
+(-0.0030 -0.0465 0.2055)
+(0.0000 -0.0465 0.2055)
+(0.0030 -0.0465 0.2055)
+(0.0060 -0.0465 0.2055)
+(-0.0060 -0.0435 0.2055)
+(-0.0030 -0.0435 0.2055)
+(0.0000 -0.0435 0.2055)
+(0.0030 -0.0435 0.2055)
+(0.0060 -0.0435 0.2055)
+(-0.0060 -0.0405 0.2055)
+(-0.0030 -0.0405 0.2055)
+(0.0000 -0.0405 0.2055)
+(0.0030 -0.0405 0.2055)
+(0.0060 -0.0405 0.2055)
+(-0.0060 -0.0375 0.2055)
+(-0.0030 -0.0375 0.2055)
+(0.0000 -0.0375 0.2055)
+(0.0030 -0.0375 0.2055)
+(0.0060 -0.0375 0.2055)
+(-0.0060 -0.0345 0.2055)
+(-0.0030 -0.0345 0.2055)
+(0.0000 -0.0345 0.2055)
+(0.0030 -0.0345 0.2055)
+(0.0060 -0.0345 0.2055)
+(-0.0060 -0.0315 0.2055)
+(-0.0030 -0.0315 0.2055)
+(0.0000 -0.0315 0.2055)
+(0.0030 -0.0315 0.2055)
+(0.0060 -0.0315 0.2055)
+(-0.0060 -0.0285 0.2055)
+(-0.0030 -0.0285 0.2055)
+(0.0000 -0.0285 0.2055)
+(0.0030 -0.0285 0.2055)
+(0.0060 -0.0285 0.2055)
+(-0.0060 -0.0255 0.2055)
+(-0.0030 -0.0255 0.2055)
+(0.0000 -0.0255 0.2055)
+(0.0030 -0.0255 0.2055)
+(0.0060 -0.0255 0.2055)
+(-0.0060 -0.0225 0.2055)
+(-0.0030 -0.0225 0.2055)
+(0.0000 -0.0225 0.2055)
+(0.0030 -0.0225 0.2055)
+(0.0060 -0.0225 0.2055)
+(-0.0060 -0.0195 0.2055)
+(-0.0030 -0.0195 0.2055)
+(0.0000 -0.0195 0.2055)
+(0.0030 -0.0195 0.2055)
+(0.0060 -0.0195 0.2055)
+(-0.0060 -0.0165 0.2055)
+(-0.0030 -0.0165 0.2055)
+(0.0000 -0.0165 0.2055)
+(0.0030 -0.0165 0.2055)
+(0.0060 -0.0165 0.2055)
+(-0.0060 -0.0135 0.2055)
+(-0.0030 -0.0135 0.2055)
+(0.0000 -0.0135 0.2055)
+(0.0030 -0.0135 0.2055)
+(0.0060 -0.0135 0.2055)
+(-0.0060 -0.0105 0.2055)
+(-0.0030 -0.0105 0.2055)
+(0.0000 -0.0105 0.2055)
+(0.0030 -0.0105 0.2055)
+(0.0060 -0.0105 0.2055)
+(-0.0060 -0.0075 0.2055)
+(-0.0030 -0.0075 0.2055)
+(0.0000 -0.0075 0.2055)
+(0.0030 -0.0075 0.2055)
+(0.0060 -0.0075 0.2055)
+(-0.0060 -0.0045 0.2055)
+(-0.0030 -0.0045 0.2055)
+(0.0000 -0.0045 0.2055)
+(0.0030 -0.0045 0.2055)
+(0.0060 -0.0045 0.2055)
+(-0.0060 -0.0015 0.2055)
+(-0.0030 -0.0015 0.2055)
+(0.0000 -0.0015 0.2055)
+(0.0030 -0.0015 0.2055)
+(0.0060 -0.0015 0.2055)
+(-0.0060 0.0015 0.2055)
+(-0.0030 0.0015 0.2055)
+(0.0000 0.0015 0.2055)
+(0.0030 0.0015 0.2055)
+(0.0060 0.0015 0.2055)
+(-0.0060 0.0045 0.2055)
+(-0.0030 0.0045 0.2055)
+(0.0000 0.0045 0.2055)
+(0.0030 0.0045 0.2055)
+(0.0060 0.0045 0.2055)
+(-0.0060 0.0075 0.2055)
+(-0.0030 0.0075 0.2055)
+(0.0000 0.0075 0.2055)
+(0.0030 0.0075 0.2055)
+(0.0060 0.0075 0.2055)
+(-0.0060 0.0105 0.2055)
+(-0.0030 0.0105 0.2055)
+(0.0000 0.0105 0.2055)
+(0.0030 0.0105 0.2055)
+(0.0060 0.0105 0.2055)
+(-0.0060 0.0135 0.2055)
+(-0.0030 0.0135 0.2055)
+(0.0000 0.0135 0.2055)
+(0.0030 0.0135 0.2055)
+(0.0060 0.0135 0.2055)
+(-0.0060 0.0165 0.2055)
+(-0.0030 0.0165 0.2055)
+(0.0000 0.0165 0.2055)
+(0.0030 0.0165 0.2055)
+(0.0060 0.0165 0.2055)
+(-0.0060 0.0195 0.2055)
+(-0.0030 0.0195 0.2055)
+(0.0000 0.0195 0.2055)
+(0.0030 0.0195 0.2055)
+(0.0060 0.0195 0.2055)
+(-0.0060 0.0225 0.2055)
+(-0.0030 0.0225 0.2055)
+(0.0000 0.0225 0.2055)
+(0.0030 0.0225 0.2055)
+(0.0060 0.0225 0.2055)
+(-0.0060 0.0255 0.2055)
+(-0.0030 0.0255 0.2055)
+(0.0000 0.0255 0.2055)
+(0.0030 0.0255 0.2055)
+(0.0060 0.0255 0.2055)
+(-0.0060 0.0285 0.2055)
+(-0.0030 0.0285 0.2055)
+(0.0000 0.0285 0.2055)
+(0.0030 0.0285 0.2055)
+(0.0060 0.0285 0.2055)
+(-0.0060 0.0315 0.2055)
+(-0.0030 0.0315 0.2055)
+(0.0000 0.0315 0.2055)
+(0.0030 0.0315 0.2055)
+(0.0060 0.0315 0.2055)
+(-0.0060 0.0345 0.2055)
+(-0.0030 0.0345 0.2055)
+(0.0000 0.0345 0.2055)
+(0.0030 0.0345 0.2055)
+(0.0060 0.0345 0.2055)
+(-0.0060 0.0375 0.2055)
+(-0.0030 0.0375 0.2055)
+(0.0000 0.0375 0.2055)
+(0.0030 0.0375 0.2055)
+(0.0060 0.0375 0.2055)
+(-0.0060 0.0405 0.2055)
+(-0.0030 0.0405 0.2055)
+(0.0000 0.0405 0.2055)
+(0.0030 0.0405 0.2055)
+(0.0060 0.0405 0.2055)
+(-0.0060 0.0435 0.2055)
+(-0.0030 0.0435 0.2055)
+(0.0000 0.0435 0.2055)
+(0.0030 0.0435 0.2055)
+(0.0060 0.0435 0.2055)
+(-0.0060 0.0465 0.2055)
+(-0.0030 0.0465 0.2055)
+(0.0000 0.0465 0.2055)
+(0.0030 0.0465 0.2055)
+(0.0060 0.0465 0.2055)
+(-0.0060 0.0495 0.2055)
+(-0.0030 0.0495 0.2055)
+(0.0000 0.0495 0.2055)
+(0.0030 0.0495 0.2055)
+(0.0060 0.0495 0.2055)
+(-0.0060 0.0525 0.2055)
+(-0.0030 0.0525 0.2055)
+(0.0000 0.0525 0.2055)
+(0.0030 0.0525 0.2055)
+(0.0060 0.0525 0.2055)
+(-0.0060 0.0555 0.2055)
+(-0.0030 0.0555 0.2055)
+(0.0000 0.0555 0.2055)
+(0.0030 0.0555 0.2055)
+(0.0060 0.0555 0.2055)
+(-0.0060 0.0585 0.2055)
+(-0.0030 0.0585 0.2055)
+(0.0000 0.0585 0.2055)
+(0.0030 0.0585 0.2055)
+(0.0060 0.0585 0.2055)
+(-0.0060 0.0615 0.2055)
+(-0.0030 0.0615 0.2055)
+(0.0000 0.0615 0.2055)
+(0.0030 0.0615 0.2055)
+(0.0060 0.0615 0.2055)
+(-0.0060 0.0645 0.2055)
+(-0.0030 0.0645 0.2055)
+(0.0000 0.0645 0.2055)
+(0.0030 0.0645 0.2055)
+(0.0060 0.0645 0.2055)
+(-0.0060 0.0675 0.2055)
+(-0.0030 0.0675 0.2055)
+(0.0000 0.0675 0.2055)
+(0.0030 0.0675 0.2055)
+(0.0060 0.0675 0.2055)
+(-0.0060 0.0705 0.2055)
+(-0.0030 0.0705 0.2055)
+(0.0000 0.0705 0.2055)
+(0.0030 0.0705 0.2055)
+(0.0060 0.0705 0.2055)
+(-0.0060 0.0735 0.2055)
+(-0.0030 0.0735 0.2055)
+(0.0000 0.0735 0.2055)
+(0.0030 0.0735 0.2055)
+(0.0060 0.0735 0.2055)
+(-0.0060 -0.0735 0.2085)
+(-0.0030 -0.0735 0.2085)
+(0.0000 -0.0735 0.2085)
+(0.0030 -0.0735 0.2085)
+(0.0060 -0.0735 0.2085)
+(-0.0060 -0.0705 0.2085)
+(-0.0030 -0.0705 0.2085)
+(0.0000 -0.0705 0.2085)
+(0.0030 -0.0705 0.2085)
+(0.0060 -0.0705 0.2085)
+(-0.0060 -0.0675 0.2085)
+(-0.0030 -0.0675 0.2085)
+(0.0000 -0.0675 0.2085)
+(0.0030 -0.0675 0.2085)
+(0.0060 -0.0675 0.2085)
+(-0.0060 -0.0645 0.2085)
+(-0.0030 -0.0645 0.2085)
+(0.0000 -0.0645 0.2085)
+(0.0030 -0.0645 0.2085)
+(0.0060 -0.0645 0.2085)
+(-0.0060 -0.0615 0.2085)
+(-0.0030 -0.0615 0.2085)
+(0.0000 -0.0615 0.2085)
+(0.0030 -0.0615 0.2085)
+(0.0060 -0.0615 0.2085)
+(-0.0060 -0.0585 0.2085)
+(-0.0030 -0.0585 0.2085)
+(0.0000 -0.0585 0.2085)
+(0.0030 -0.0585 0.2085)
+(0.0060 -0.0585 0.2085)
+(-0.0060 -0.0555 0.2085)
+(-0.0030 -0.0555 0.2085)
+(0.0000 -0.0555 0.2085)
+(0.0030 -0.0555 0.2085)
+(0.0060 -0.0555 0.2085)
+(-0.0060 -0.0525 0.2085)
+(-0.0030 -0.0525 0.2085)
+(0.0000 -0.0525 0.2085)
+(0.0030 -0.0525 0.2085)
+(0.0060 -0.0525 0.2085)
+(-0.0060 -0.0495 0.2085)
+(-0.0030 -0.0495 0.2085)
+(0.0000 -0.0495 0.2085)
+(0.0030 -0.0495 0.2085)
+(0.0060 -0.0495 0.2085)
+(-0.0060 -0.0465 0.2085)
+(-0.0030 -0.0465 0.2085)
+(0.0000 -0.0465 0.2085)
+(0.0030 -0.0465 0.2085)
+(0.0060 -0.0465 0.2085)
+(-0.0060 -0.0435 0.2085)
+(-0.0030 -0.0435 0.2085)
+(0.0000 -0.0435 0.2085)
+(0.0030 -0.0435 0.2085)
+(0.0060 -0.0435 0.2085)
+(-0.0060 -0.0405 0.2085)
+(-0.0030 -0.0405 0.2085)
+(0.0000 -0.0405 0.2085)
+(0.0030 -0.0405 0.2085)
+(0.0060 -0.0405 0.2085)
+(-0.0060 -0.0375 0.2085)
+(-0.0030 -0.0375 0.2085)
+(0.0000 -0.0375 0.2085)
+(0.0030 -0.0375 0.2085)
+(0.0060 -0.0375 0.2085)
+(-0.0060 -0.0345 0.2085)
+(-0.0030 -0.0345 0.2085)
+(0.0000 -0.0345 0.2085)
+(0.0030 -0.0345 0.2085)
+(0.0060 -0.0345 0.2085)
+(-0.0060 -0.0315 0.2085)
+(-0.0030 -0.0315 0.2085)
+(0.0000 -0.0315 0.2085)
+(0.0030 -0.0315 0.2085)
+(0.0060 -0.0315 0.2085)
+(-0.0060 -0.0285 0.2085)
+(-0.0030 -0.0285 0.2085)
+(0.0000 -0.0285 0.2085)
+(0.0030 -0.0285 0.2085)
+(0.0060 -0.0285 0.2085)
+(-0.0060 -0.0255 0.2085)
+(-0.0030 -0.0255 0.2085)
+(0.0000 -0.0255 0.2085)
+(0.0030 -0.0255 0.2085)
+(0.0060 -0.0255 0.2085)
+(-0.0060 -0.0225 0.2085)
+(-0.0030 -0.0225 0.2085)
+(0.0000 -0.0225 0.2085)
+(0.0030 -0.0225 0.2085)
+(0.0060 -0.0225 0.2085)
+(-0.0060 -0.0195 0.2085)
+(-0.0030 -0.0195 0.2085)
+(0.0000 -0.0195 0.2085)
+(0.0030 -0.0195 0.2085)
+(0.0060 -0.0195 0.2085)
+(-0.0060 -0.0165 0.2085)
+(-0.0030 -0.0165 0.2085)
+(0.0000 -0.0165 0.2085)
+(0.0030 -0.0165 0.2085)
+(0.0060 -0.0165 0.2085)
+(-0.0060 -0.0135 0.2085)
+(-0.0030 -0.0135 0.2085)
+(0.0000 -0.0135 0.2085)
+(0.0030 -0.0135 0.2085)
+(0.0060 -0.0135 0.2085)
+(-0.0060 -0.0105 0.2085)
+(-0.0030 -0.0105 0.2085)
+(0.0000 -0.0105 0.2085)
+(0.0030 -0.0105 0.2085)
+(0.0060 -0.0105 0.2085)
+(-0.0060 -0.0075 0.2085)
+(-0.0030 -0.0075 0.2085)
+(0.0000 -0.0075 0.2085)
+(0.0030 -0.0075 0.2085)
+(0.0060 -0.0075 0.2085)
+(-0.0060 -0.0045 0.2085)
+(-0.0030 -0.0045 0.2085)
+(0.0000 -0.0045 0.2085)
+(0.0030 -0.0045 0.2085)
+(0.0060 -0.0045 0.2085)
+(-0.0060 -0.0015 0.2085)
+(-0.0030 -0.0015 0.2085)
+(0.0000 -0.0015 0.2085)
+(0.0030 -0.0015 0.2085)
+(0.0060 -0.0015 0.2085)
+(-0.0060 0.0015 0.2085)
+(-0.0030 0.0015 0.2085)
+(0.0000 0.0015 0.2085)
+(0.0030 0.0015 0.2085)
+(0.0060 0.0015 0.2085)
+(-0.0060 0.0045 0.2085)
+(-0.0030 0.0045 0.2085)
+(0.0000 0.0045 0.2085)
+(0.0030 0.0045 0.2085)
+(0.0060 0.0045 0.2085)
+(-0.0060 0.0075 0.2085)
+(-0.0030 0.0075 0.2085)
+(0.0000 0.0075 0.2085)
+(0.0030 0.0075 0.2085)
+(0.0060 0.0075 0.2085)
+(-0.0060 0.0105 0.2085)
+(-0.0030 0.0105 0.2085)
+(0.0000 0.0105 0.2085)
+(0.0030 0.0105 0.2085)
+(0.0060 0.0105 0.2085)
+(-0.0060 0.0135 0.2085)
+(-0.0030 0.0135 0.2085)
+(0.0000 0.0135 0.2085)
+(0.0030 0.0135 0.2085)
+(0.0060 0.0135 0.2085)
+(-0.0060 0.0165 0.2085)
+(-0.0030 0.0165 0.2085)
+(0.0000 0.0165 0.2085)
+(0.0030 0.0165 0.2085)
+(0.0060 0.0165 0.2085)
+(-0.0060 0.0195 0.2085)
+(-0.0030 0.0195 0.2085)
+(0.0000 0.0195 0.2085)
+(0.0030 0.0195 0.2085)
+(0.0060 0.0195 0.2085)
+(-0.0060 0.0225 0.2085)
+(-0.0030 0.0225 0.2085)
+(0.0000 0.0225 0.2085)
+(0.0030 0.0225 0.2085)
+(0.0060 0.0225 0.2085)
+(-0.0060 0.0255 0.2085)
+(-0.0030 0.0255 0.2085)
+(0.0000 0.0255 0.2085)
+(0.0030 0.0255 0.2085)
+(0.0060 0.0255 0.2085)
+(-0.0060 0.0285 0.2085)
+(-0.0030 0.0285 0.2085)
+(0.0000 0.0285 0.2085)
+(0.0030 0.0285 0.2085)
+(0.0060 0.0285 0.2085)
+(-0.0060 0.0315 0.2085)
+(-0.0030 0.0315 0.2085)
+(0.0000 0.0315 0.2085)
+(0.0030 0.0315 0.2085)
+(0.0060 0.0315 0.2085)
+(-0.0060 0.0345 0.2085)
+(-0.0030 0.0345 0.2085)
+(0.0000 0.0345 0.2085)
+(0.0030 0.0345 0.2085)
+(0.0060 0.0345 0.2085)
+(-0.0060 0.0375 0.2085)
+(-0.0030 0.0375 0.2085)
+(0.0000 0.0375 0.2085)
+(0.0030 0.0375 0.2085)
+(0.0060 0.0375 0.2085)
+(-0.0060 0.0405 0.2085)
+(-0.0030 0.0405 0.2085)
+(0.0000 0.0405 0.2085)
+(0.0030 0.0405 0.2085)
+(0.0060 0.0405 0.2085)
+(-0.0060 0.0435 0.2085)
+(-0.0030 0.0435 0.2085)
+(0.0000 0.0435 0.2085)
+(0.0030 0.0435 0.2085)
+(0.0060 0.0435 0.2085)
+(-0.0060 0.0465 0.2085)
+(-0.0030 0.0465 0.2085)
+(0.0000 0.0465 0.2085)
+(0.0030 0.0465 0.2085)
+(0.0060 0.0465 0.2085)
+(-0.0060 0.0495 0.2085)
+(-0.0030 0.0495 0.2085)
+(0.0000 0.0495 0.2085)
+(0.0030 0.0495 0.2085)
+(0.0060 0.0495 0.2085)
+(-0.0060 0.0525 0.2085)
+(-0.0030 0.0525 0.2085)
+(0.0000 0.0525 0.2085)
+(0.0030 0.0525 0.2085)
+(0.0060 0.0525 0.2085)
+(-0.0060 0.0555 0.2085)
+(-0.0030 0.0555 0.2085)
+(0.0000 0.0555 0.2085)
+(0.0030 0.0555 0.2085)
+(0.0060 0.0555 0.2085)
+(-0.0060 0.0585 0.2085)
+(-0.0030 0.0585 0.2085)
+(0.0000 0.0585 0.2085)
+(0.0030 0.0585 0.2085)
+(0.0060 0.0585 0.2085)
+(-0.0060 0.0615 0.2085)
+(-0.0030 0.0615 0.2085)
+(0.0000 0.0615 0.2085)
+(0.0030 0.0615 0.2085)
+(0.0060 0.0615 0.2085)
+(-0.0060 0.0645 0.2085)
+(-0.0030 0.0645 0.2085)
+(0.0000 0.0645 0.2085)
+(0.0030 0.0645 0.2085)
+(0.0060 0.0645 0.2085)
+(-0.0060 0.0675 0.2085)
+(-0.0030 0.0675 0.2085)
+(0.0000 0.0675 0.2085)
+(0.0030 0.0675 0.2085)
+(0.0060 0.0675 0.2085)
+(-0.0060 0.0705 0.2085)
+(-0.0030 0.0705 0.2085)
+(0.0000 0.0705 0.2085)
+(0.0030 0.0705 0.2085)
+(0.0060 0.0705 0.2085)
+(-0.0060 0.0735 0.2085)
+(-0.0030 0.0735 0.2085)
+(0.0000 0.0735 0.2085)
+(0.0030 0.0735 0.2085)
+(0.0060 0.0735 0.2085)
+(-0.0060 -0.0735 0.2115)
+(-0.0030 -0.0735 0.2115)
+(0.0000 -0.0735 0.2115)
+(0.0030 -0.0735 0.2115)
+(0.0060 -0.0735 0.2115)
+(-0.0060 -0.0705 0.2115)
+(-0.0030 -0.0705 0.2115)
+(0.0000 -0.0705 0.2115)
+(0.0030 -0.0705 0.2115)
+(0.0060 -0.0705 0.2115)
+(-0.0060 -0.0675 0.2115)
+(-0.0030 -0.0675 0.2115)
+(0.0000 -0.0675 0.2115)
+(0.0030 -0.0675 0.2115)
+(0.0060 -0.0675 0.2115)
+(-0.0060 -0.0645 0.2115)
+(-0.0030 -0.0645 0.2115)
+(0.0000 -0.0645 0.2115)
+(0.0030 -0.0645 0.2115)
+(0.0060 -0.0645 0.2115)
+(-0.0060 -0.0615 0.2115)
+(-0.0030 -0.0615 0.2115)
+(0.0000 -0.0615 0.2115)
+(0.0030 -0.0615 0.2115)
+(0.0060 -0.0615 0.2115)
+(-0.0060 -0.0585 0.2115)
+(-0.0030 -0.0585 0.2115)
+(0.0000 -0.0585 0.2115)
+(0.0030 -0.0585 0.2115)
+(0.0060 -0.0585 0.2115)
+(-0.0060 -0.0555 0.2115)
+(-0.0030 -0.0555 0.2115)
+(0.0000 -0.0555 0.2115)
+(0.0030 -0.0555 0.2115)
+(0.0060 -0.0555 0.2115)
+(-0.0060 -0.0525 0.2115)
+(-0.0030 -0.0525 0.2115)
+(0.0000 -0.0525 0.2115)
+(0.0030 -0.0525 0.2115)
+(0.0060 -0.0525 0.2115)
+(-0.0060 -0.0495 0.2115)
+(-0.0030 -0.0495 0.2115)
+(0.0000 -0.0495 0.2115)
+(0.0030 -0.0495 0.2115)
+(0.0060 -0.0495 0.2115)
+(-0.0060 -0.0465 0.2115)
+(-0.0030 -0.0465 0.2115)
+(0.0000 -0.0465 0.2115)
+(0.0030 -0.0465 0.2115)
+(0.0060 -0.0465 0.2115)
+(-0.0060 -0.0435 0.2115)
+(-0.0030 -0.0435 0.2115)
+(0.0000 -0.0435 0.2115)
+(0.0030 -0.0435 0.2115)
+(0.0060 -0.0435 0.2115)
+(-0.0060 -0.0405 0.2115)
+(-0.0030 -0.0405 0.2115)
+(0.0000 -0.0405 0.2115)
+(0.0030 -0.0405 0.2115)
+(0.0060 -0.0405 0.2115)
+(-0.0060 -0.0375 0.2115)
+(-0.0030 -0.0375 0.2115)
+(0.0000 -0.0375 0.2115)
+(0.0030 -0.0375 0.2115)
+(0.0060 -0.0375 0.2115)
+(-0.0060 -0.0345 0.2115)
+(-0.0030 -0.0345 0.2115)
+(0.0000 -0.0345 0.2115)
+(0.0030 -0.0345 0.2115)
+(0.0060 -0.0345 0.2115)
+(-0.0060 -0.0315 0.2115)
+(-0.0030 -0.0315 0.2115)
+(0.0000 -0.0315 0.2115)
+(0.0030 -0.0315 0.2115)
+(0.0060 -0.0315 0.2115)
+(-0.0060 -0.0285 0.2115)
+(-0.0030 -0.0285 0.2115)
+(0.0000 -0.0285 0.2115)
+(0.0030 -0.0285 0.2115)
+(0.0060 -0.0285 0.2115)
+(-0.0060 -0.0255 0.2115)
+(-0.0030 -0.0255 0.2115)
+(0.0000 -0.0255 0.2115)
+(0.0030 -0.0255 0.2115)
+(0.0060 -0.0255 0.2115)
+(-0.0060 -0.0225 0.2115)
+(-0.0030 -0.0225 0.2115)
+(0.0000 -0.0225 0.2115)
+(0.0030 -0.0225 0.2115)
+(0.0060 -0.0225 0.2115)
+(-0.0060 -0.0195 0.2115)
+(-0.0030 -0.0195 0.2115)
+(0.0000 -0.0195 0.2115)
+(0.0030 -0.0195 0.2115)
+(0.0060 -0.0195 0.2115)
+(-0.0060 -0.0165 0.2115)
+(-0.0030 -0.0165 0.2115)
+(0.0000 -0.0165 0.2115)
+(0.0030 -0.0165 0.2115)
+(0.0060 -0.0165 0.2115)
+(-0.0060 -0.0135 0.2115)
+(-0.0030 -0.0135 0.2115)
+(0.0000 -0.0135 0.2115)
+(0.0030 -0.0135 0.2115)
+(0.0060 -0.0135 0.2115)
+(-0.0060 -0.0105 0.2115)
+(-0.0030 -0.0105 0.2115)
+(0.0000 -0.0105 0.2115)
+(0.0030 -0.0105 0.2115)
+(0.0060 -0.0105 0.2115)
+(-0.0060 -0.0075 0.2115)
+(-0.0030 -0.0075 0.2115)
+(0.0000 -0.0075 0.2115)
+(0.0030 -0.0075 0.2115)
+(0.0060 -0.0075 0.2115)
+(-0.0060 -0.0045 0.2115)
+(-0.0030 -0.0045 0.2115)
+(0.0000 -0.0045 0.2115)
+(0.0030 -0.0045 0.2115)
+(0.0060 -0.0045 0.2115)
+(-0.0060 -0.0015 0.2115)
+(-0.0030 -0.0015 0.2115)
+(0.0000 -0.0015 0.2115)
+(0.0030 -0.0015 0.2115)
+(0.0060 -0.0015 0.2115)
+(-0.0060 0.0015 0.2115)
+(-0.0030 0.0015 0.2115)
+(0.0000 0.0015 0.2115)
+(0.0030 0.0015 0.2115)
+(0.0060 0.0015 0.2115)
+(-0.0060 0.0045 0.2115)
+(-0.0030 0.0045 0.2115)
+(0.0000 0.0045 0.2115)
+(0.0030 0.0045 0.2115)
+(0.0060 0.0045 0.2115)
+(-0.0060 0.0075 0.2115)
+(-0.0030 0.0075 0.2115)
+(0.0000 0.0075 0.2115)
+(0.0030 0.0075 0.2115)
+(0.0060 0.0075 0.2115)
+(-0.0060 0.0105 0.2115)
+(-0.0030 0.0105 0.2115)
+(0.0000 0.0105 0.2115)
+(0.0030 0.0105 0.2115)
+(0.0060 0.0105 0.2115)
+(-0.0060 0.0135 0.2115)
+(-0.0030 0.0135 0.2115)
+(0.0000 0.0135 0.2115)
+(0.0030 0.0135 0.2115)
+(0.0060 0.0135 0.2115)
+(-0.0060 0.0165 0.2115)
+(-0.0030 0.0165 0.2115)
+(0.0000 0.0165 0.2115)
+(0.0030 0.0165 0.2115)
+(0.0060 0.0165 0.2115)
+(-0.0060 0.0195 0.2115)
+(-0.0030 0.0195 0.2115)
+(0.0000 0.0195 0.2115)
+(0.0030 0.0195 0.2115)
+(0.0060 0.0195 0.2115)
+(-0.0060 0.0225 0.2115)
+(-0.0030 0.0225 0.2115)
+(0.0000 0.0225 0.2115)
+(0.0030 0.0225 0.2115)
+(0.0060 0.0225 0.2115)
+(-0.0060 0.0255 0.2115)
+(-0.0030 0.0255 0.2115)
+(0.0000 0.0255 0.2115)
+(0.0030 0.0255 0.2115)
+(0.0060 0.0255 0.2115)
+(-0.0060 0.0285 0.2115)
+(-0.0030 0.0285 0.2115)
+(0.0000 0.0285 0.2115)
+(0.0030 0.0285 0.2115)
+(0.0060 0.0285 0.2115)
+(-0.0060 0.0315 0.2115)
+(-0.0030 0.0315 0.2115)
+(0.0000 0.0315 0.2115)
+(0.0030 0.0315 0.2115)
+(0.0060 0.0315 0.2115)
+(-0.0060 0.0345 0.2115)
+(-0.0030 0.0345 0.2115)
+(0.0000 0.0345 0.2115)
+(0.0030 0.0345 0.2115)
+(0.0060 0.0345 0.2115)
+(-0.0060 0.0375 0.2115)
+(-0.0030 0.0375 0.2115)
+(0.0000 0.0375 0.2115)
+(0.0030 0.0375 0.2115)
+(0.0060 0.0375 0.2115)
+(-0.0060 0.0405 0.2115)
+(-0.0030 0.0405 0.2115)
+(0.0000 0.0405 0.2115)
+(0.0030 0.0405 0.2115)
+(0.0060 0.0405 0.2115)
+(-0.0060 0.0435 0.2115)
+(-0.0030 0.0435 0.2115)
+(0.0000 0.0435 0.2115)
+(0.0030 0.0435 0.2115)
+(0.0060 0.0435 0.2115)
+(-0.0060 0.0465 0.2115)
+(-0.0030 0.0465 0.2115)
+(0.0000 0.0465 0.2115)
+(0.0030 0.0465 0.2115)
+(0.0060 0.0465 0.2115)
+(-0.0060 0.0495 0.2115)
+(-0.0030 0.0495 0.2115)
+(0.0000 0.0495 0.2115)
+(0.0030 0.0495 0.2115)
+(0.0060 0.0495 0.2115)
+(-0.0060 0.0525 0.2115)
+(-0.0030 0.0525 0.2115)
+(0.0000 0.0525 0.2115)
+(0.0030 0.0525 0.2115)
+(0.0060 0.0525 0.2115)
+(-0.0060 0.0555 0.2115)
+(-0.0030 0.0555 0.2115)
+(0.0000 0.0555 0.2115)
+(0.0030 0.0555 0.2115)
+(0.0060 0.0555 0.2115)
+(-0.0060 0.0585 0.2115)
+(-0.0030 0.0585 0.2115)
+(0.0000 0.0585 0.2115)
+(0.0030 0.0585 0.2115)
+(0.0060 0.0585 0.2115)
+(-0.0060 0.0615 0.2115)
+(-0.0030 0.0615 0.2115)
+(0.0000 0.0615 0.2115)
+(0.0030 0.0615 0.2115)
+(0.0060 0.0615 0.2115)
+(-0.0060 0.0645 0.2115)
+(-0.0030 0.0645 0.2115)
+(0.0000 0.0645 0.2115)
+(0.0030 0.0645 0.2115)
+(0.0060 0.0645 0.2115)
+(-0.0060 0.0675 0.2115)
+(-0.0030 0.0675 0.2115)
+(0.0000 0.0675 0.2115)
+(0.0030 0.0675 0.2115)
+(0.0060 0.0675 0.2115)
+(-0.0060 0.0705 0.2115)
+(-0.0030 0.0705 0.2115)
+(0.0000 0.0705 0.2115)
+(0.0030 0.0705 0.2115)
+(0.0060 0.0705 0.2115)
+(-0.0060 0.0735 0.2115)
+(-0.0030 0.0735 0.2115)
+(0.0000 0.0735 0.2115)
+(0.0030 0.0735 0.2115)
+(0.0060 0.0735 0.2115)
+(-0.0060 -0.0735 0.2145)
+(-0.0030 -0.0735 0.2145)
+(0.0000 -0.0735 0.2145)
+(0.0030 -0.0735 0.2145)
+(0.0060 -0.0735 0.2145)
+(-0.0060 -0.0705 0.2145)
+(-0.0030 -0.0705 0.2145)
+(0.0000 -0.0705 0.2145)
+(0.0030 -0.0705 0.2145)
+(0.0060 -0.0705 0.2145)
+(-0.0060 -0.0675 0.2145)
+(-0.0030 -0.0675 0.2145)
+(0.0000 -0.0675 0.2145)
+(0.0030 -0.0675 0.2145)
+(0.0060 -0.0675 0.2145)
+(-0.0060 -0.0645 0.2145)
+(-0.0030 -0.0645 0.2145)
+(0.0000 -0.0645 0.2145)
+(0.0030 -0.0645 0.2145)
+(0.0060 -0.0645 0.2145)
+(-0.0060 -0.0615 0.2145)
+(-0.0030 -0.0615 0.2145)
+(0.0000 -0.0615 0.2145)
+(0.0030 -0.0615 0.2145)
+(0.0060 -0.0615 0.2145)
+(-0.0060 -0.0585 0.2145)
+(-0.0030 -0.0585 0.2145)
+(0.0000 -0.0585 0.2145)
+(0.0030 -0.0585 0.2145)
+(0.0060 -0.0585 0.2145)
+(-0.0060 -0.0555 0.2145)
+(-0.0030 -0.0555 0.2145)
+(0.0000 -0.0555 0.2145)
+(0.0030 -0.0555 0.2145)
+(0.0060 -0.0555 0.2145)
+(-0.0060 -0.0525 0.2145)
+(-0.0030 -0.0525 0.2145)
+(0.0000 -0.0525 0.2145)
+(0.0030 -0.0525 0.2145)
+(0.0060 -0.0525 0.2145)
+(-0.0060 -0.0495 0.2145)
+(-0.0030 -0.0495 0.2145)
+(0.0000 -0.0495 0.2145)
+(0.0030 -0.0495 0.2145)
+(0.0060 -0.0495 0.2145)
+(-0.0060 -0.0465 0.2145)
+(-0.0030 -0.0465 0.2145)
+(0.0000 -0.0465 0.2145)
+(0.0030 -0.0465 0.2145)
+(0.0060 -0.0465 0.2145)
+(-0.0060 -0.0435 0.2145)
+(-0.0030 -0.0435 0.2145)
+(0.0000 -0.0435 0.2145)
+(0.0030 -0.0435 0.2145)
+(0.0060 -0.0435 0.2145)
+(-0.0060 -0.0405 0.2145)
+(-0.0030 -0.0405 0.2145)
+(0.0000 -0.0405 0.2145)
+(0.0030 -0.0405 0.2145)
+(0.0060 -0.0405 0.2145)
+(-0.0060 -0.0375 0.2145)
+(-0.0030 -0.0375 0.2145)
+(0.0000 -0.0375 0.2145)
+(0.0030 -0.0375 0.2145)
+(0.0060 -0.0375 0.2145)
+(-0.0060 -0.0345 0.2145)
+(-0.0030 -0.0345 0.2145)
+(0.0000 -0.0345 0.2145)
+(0.0030 -0.0345 0.2145)
+(0.0060 -0.0345 0.2145)
+(-0.0060 -0.0315 0.2145)
+(-0.0030 -0.0315 0.2145)
+(0.0000 -0.0315 0.2145)
+(0.0030 -0.0315 0.2145)
+(0.0060 -0.0315 0.2145)
+(-0.0060 -0.0285 0.2145)
+(-0.0030 -0.0285 0.2145)
+(0.0000 -0.0285 0.2145)
+(0.0030 -0.0285 0.2145)
+(0.0060 -0.0285 0.2145)
+(-0.0060 -0.0255 0.2145)
+(-0.0030 -0.0255 0.2145)
+(0.0000 -0.0255 0.2145)
+(0.0030 -0.0255 0.2145)
+(0.0060 -0.0255 0.2145)
+(-0.0060 -0.0225 0.2145)
+(-0.0030 -0.0225 0.2145)
+(0.0000 -0.0225 0.2145)
+(0.0030 -0.0225 0.2145)
+(0.0060 -0.0225 0.2145)
+(-0.0060 -0.0195 0.2145)
+(-0.0030 -0.0195 0.2145)
+(0.0000 -0.0195 0.2145)
+(0.0030 -0.0195 0.2145)
+(0.0060 -0.0195 0.2145)
+(-0.0060 -0.0165 0.2145)
+(-0.0030 -0.0165 0.2145)
+(0.0000 -0.0165 0.2145)
+(0.0030 -0.0165 0.2145)
+(0.0060 -0.0165 0.2145)
+(-0.0060 -0.0135 0.2145)
+(-0.0030 -0.0135 0.2145)
+(0.0000 -0.0135 0.2145)
+(0.0030 -0.0135 0.2145)
+(0.0060 -0.0135 0.2145)
+(-0.0060 -0.0105 0.2145)
+(-0.0030 -0.0105 0.2145)
+(0.0000 -0.0105 0.2145)
+(0.0030 -0.0105 0.2145)
+(0.0060 -0.0105 0.2145)
+(-0.0060 -0.0075 0.2145)
+(-0.0030 -0.0075 0.2145)
+(0.0000 -0.0075 0.2145)
+(0.0030 -0.0075 0.2145)
+(0.0060 -0.0075 0.2145)
+(-0.0060 -0.0045 0.2145)
+(-0.0030 -0.0045 0.2145)
+(0.0000 -0.0045 0.2145)
+(0.0030 -0.0045 0.2145)
+(0.0060 -0.0045 0.2145)
+(-0.0060 -0.0015 0.2145)
+(-0.0030 -0.0015 0.2145)
+(0.0000 -0.0015 0.2145)
+(0.0030 -0.0015 0.2145)
+(0.0060 -0.0015 0.2145)
+(-0.0060 0.0015 0.2145)
+(-0.0030 0.0015 0.2145)
+(0.0000 0.0015 0.2145)
+(0.0030 0.0015 0.2145)
+(0.0060 0.0015 0.2145)
+(-0.0060 0.0045 0.2145)
+(-0.0030 0.0045 0.2145)
+(0.0000 0.0045 0.2145)
+(0.0030 0.0045 0.2145)
+(0.0060 0.0045 0.2145)
+(-0.0060 0.0075 0.2145)
+(-0.0030 0.0075 0.2145)
+(0.0000 0.0075 0.2145)
+(0.0030 0.0075 0.2145)
+(0.0060 0.0075 0.2145)
+(-0.0060 0.0105 0.2145)
+(-0.0030 0.0105 0.2145)
+(0.0000 0.0105 0.2145)
+(0.0030 0.0105 0.2145)
+(0.0060 0.0105 0.2145)
+(-0.0060 0.0135 0.2145)
+(-0.0030 0.0135 0.2145)
+(0.0000 0.0135 0.2145)
+(0.0030 0.0135 0.2145)
+(0.0060 0.0135 0.2145)
+(-0.0060 0.0165 0.2145)
+(-0.0030 0.0165 0.2145)
+(0.0000 0.0165 0.2145)
+(0.0030 0.0165 0.2145)
+(0.0060 0.0165 0.2145)
+(-0.0060 0.0195 0.2145)
+(-0.0030 0.0195 0.2145)
+(0.0000 0.0195 0.2145)
+(0.0030 0.0195 0.2145)
+(0.0060 0.0195 0.2145)
+(-0.0060 0.0225 0.2145)
+(-0.0030 0.0225 0.2145)
+(0.0000 0.0225 0.2145)
+(0.0030 0.0225 0.2145)
+(0.0060 0.0225 0.2145)
+(-0.0060 0.0255 0.2145)
+(-0.0030 0.0255 0.2145)
+(0.0000 0.0255 0.2145)
+(0.0030 0.0255 0.2145)
+(0.0060 0.0255 0.2145)
+(-0.0060 0.0285 0.2145)
+(-0.0030 0.0285 0.2145)
+(0.0000 0.0285 0.2145)
+(0.0030 0.0285 0.2145)
+(0.0060 0.0285 0.2145)
+(-0.0060 0.0315 0.2145)
+(-0.0030 0.0315 0.2145)
+(0.0000 0.0315 0.2145)
+(0.0030 0.0315 0.2145)
+(0.0060 0.0315 0.2145)
+(-0.0060 0.0345 0.2145)
+(-0.0030 0.0345 0.2145)
+(0.0000 0.0345 0.2145)
+(0.0030 0.0345 0.2145)
+(0.0060 0.0345 0.2145)
+(-0.0060 0.0375 0.2145)
+(-0.0030 0.0375 0.2145)
+(0.0000 0.0375 0.2145)
+(0.0030 0.0375 0.2145)
+(0.0060 0.0375 0.2145)
+(-0.0060 0.0405 0.2145)
+(-0.0030 0.0405 0.2145)
+(0.0000 0.0405 0.2145)
+(0.0030 0.0405 0.2145)
+(0.0060 0.0405 0.2145)
+(-0.0060 0.0435 0.2145)
+(-0.0030 0.0435 0.2145)
+(0.0000 0.0435 0.2145)
+(0.0030 0.0435 0.2145)
+(0.0060 0.0435 0.2145)
+(-0.0060 0.0465 0.2145)
+(-0.0030 0.0465 0.2145)
+(0.0000 0.0465 0.2145)
+(0.0030 0.0465 0.2145)
+(0.0060 0.0465 0.2145)
+(-0.0060 0.0495 0.2145)
+(-0.0030 0.0495 0.2145)
+(0.0000 0.0495 0.2145)
+(0.0030 0.0495 0.2145)
+(0.0060 0.0495 0.2145)
+(-0.0060 0.0525 0.2145)
+(-0.0030 0.0525 0.2145)
+(0.0000 0.0525 0.2145)
+(0.0030 0.0525 0.2145)
+(0.0060 0.0525 0.2145)
+(-0.0060 0.0555 0.2145)
+(-0.0030 0.0555 0.2145)
+(0.0000 0.0555 0.2145)
+(0.0030 0.0555 0.2145)
+(0.0060 0.0555 0.2145)
+(-0.0060 0.0585 0.2145)
+(-0.0030 0.0585 0.2145)
+(0.0000 0.0585 0.2145)
+(0.0030 0.0585 0.2145)
+(0.0060 0.0585 0.2145)
+(-0.0060 0.0615 0.2145)
+(-0.0030 0.0615 0.2145)
+(0.0000 0.0615 0.2145)
+(0.0030 0.0615 0.2145)
+(0.0060 0.0615 0.2145)
+(-0.0060 0.0645 0.2145)
+(-0.0030 0.0645 0.2145)
+(0.0000 0.0645 0.2145)
+(0.0030 0.0645 0.2145)
+(0.0060 0.0645 0.2145)
+(-0.0060 0.0675 0.2145)
+(-0.0030 0.0675 0.2145)
+(0.0000 0.0675 0.2145)
+(0.0030 0.0675 0.2145)
+(0.0060 0.0675 0.2145)
+(-0.0060 0.0705 0.2145)
+(-0.0030 0.0705 0.2145)
+(0.0000 0.0705 0.2145)
+(0.0030 0.0705 0.2145)
+(0.0060 0.0705 0.2145)
+(-0.0060 0.0735 0.2145)
+(-0.0030 0.0735 0.2145)
+(0.0000 0.0735 0.2145)
+(0.0030 0.0735 0.2145)
+(0.0060 0.0735 0.2145)
+(-0.0060 -0.0735 0.2175)
+(-0.0030 -0.0735 0.2175)
+(0.0000 -0.0735 0.2175)
+(0.0030 -0.0735 0.2175)
+(0.0060 -0.0735 0.2175)
+(-0.0060 -0.0705 0.2175)
+(-0.0030 -0.0705 0.2175)
+(0.0000 -0.0705 0.2175)
+(0.0030 -0.0705 0.2175)
+(0.0060 -0.0705 0.2175)
+(-0.0060 -0.0675 0.2175)
+(-0.0030 -0.0675 0.2175)
+(0.0000 -0.0675 0.2175)
+(0.0030 -0.0675 0.2175)
+(0.0060 -0.0675 0.2175)
+(-0.0060 -0.0645 0.2175)
+(-0.0030 -0.0645 0.2175)
+(0.0000 -0.0645 0.2175)
+(0.0030 -0.0645 0.2175)
+(0.0060 -0.0645 0.2175)
+(-0.0060 -0.0615 0.2175)
+(-0.0030 -0.0615 0.2175)
+(0.0000 -0.0615 0.2175)
+(0.0030 -0.0615 0.2175)
+(0.0060 -0.0615 0.2175)
+(-0.0060 -0.0585 0.2175)
+(-0.0030 -0.0585 0.2175)
+(0.0000 -0.0585 0.2175)
+(0.0030 -0.0585 0.2175)
+(0.0060 -0.0585 0.2175)
+(-0.0060 -0.0555 0.2175)
+(-0.0030 -0.0555 0.2175)
+(0.0000 -0.0555 0.2175)
+(0.0030 -0.0555 0.2175)
+(0.0060 -0.0555 0.2175)
+(-0.0060 -0.0525 0.2175)
+(-0.0030 -0.0525 0.2175)
+(0.0000 -0.0525 0.2175)
+(0.0030 -0.0525 0.2175)
+(0.0060 -0.0525 0.2175)
+(-0.0060 -0.0495 0.2175)
+(-0.0030 -0.0495 0.2175)
+(0.0000 -0.0495 0.2175)
+(0.0030 -0.0495 0.2175)
+(0.0060 -0.0495 0.2175)
+(-0.0060 -0.0465 0.2175)
+(-0.0030 -0.0465 0.2175)
+(0.0000 -0.0465 0.2175)
+(0.0030 -0.0465 0.2175)
+(0.0060 -0.0465 0.2175)
+(-0.0060 -0.0435 0.2175)
+(-0.0030 -0.0435 0.2175)
+(0.0000 -0.0435 0.2175)
+(0.0030 -0.0435 0.2175)
+(0.0060 -0.0435 0.2175)
+(-0.0060 -0.0405 0.2175)
+(-0.0030 -0.0405 0.2175)
+(0.0000 -0.0405 0.2175)
+(0.0030 -0.0405 0.2175)
+(0.0060 -0.0405 0.2175)
+(-0.0060 -0.0375 0.2175)
+(-0.0030 -0.0375 0.2175)
+(0.0000 -0.0375 0.2175)
+(0.0030 -0.0375 0.2175)
+(0.0060 -0.0375 0.2175)
+(-0.0060 -0.0345 0.2175)
+(-0.0030 -0.0345 0.2175)
+(0.0000 -0.0345 0.2175)
+(0.0030 -0.0345 0.2175)
+(0.0060 -0.0345 0.2175)
+(-0.0060 -0.0315 0.2175)
+(-0.0030 -0.0315 0.2175)
+(0.0000 -0.0315 0.2175)
+(0.0030 -0.0315 0.2175)
+(0.0060 -0.0315 0.2175)
+(-0.0060 -0.0285 0.2175)
+(-0.0030 -0.0285 0.2175)
+(0.0000 -0.0285 0.2175)
+(0.0030 -0.0285 0.2175)
+(0.0060 -0.0285 0.2175)
+(-0.0060 -0.0255 0.2175)
+(-0.0030 -0.0255 0.2175)
+(0.0000 -0.0255 0.2175)
+(0.0030 -0.0255 0.2175)
+(0.0060 -0.0255 0.2175)
+(-0.0060 -0.0225 0.2175)
+(-0.0030 -0.0225 0.2175)
+(0.0000 -0.0225 0.2175)
+(0.0030 -0.0225 0.2175)
+(0.0060 -0.0225 0.2175)
+(-0.0060 -0.0195 0.2175)
+(-0.0030 -0.0195 0.2175)
+(0.0000 -0.0195 0.2175)
+(0.0030 -0.0195 0.2175)
+(0.0060 -0.0195 0.2175)
+(-0.0060 -0.0165 0.2175)
+(-0.0030 -0.0165 0.2175)
+(0.0000 -0.0165 0.2175)
+(0.0030 -0.0165 0.2175)
+(0.0060 -0.0165 0.2175)
+(-0.0060 -0.0135 0.2175)
+(-0.0030 -0.0135 0.2175)
+(0.0000 -0.0135 0.2175)
+(0.0030 -0.0135 0.2175)
+(0.0060 -0.0135 0.2175)
+(-0.0060 -0.0105 0.2175)
+(-0.0030 -0.0105 0.2175)
+(0.0000 -0.0105 0.2175)
+(0.0030 -0.0105 0.2175)
+(0.0060 -0.0105 0.2175)
+(-0.0060 -0.0075 0.2175)
+(-0.0030 -0.0075 0.2175)
+(0.0000 -0.0075 0.2175)
+(0.0030 -0.0075 0.2175)
+(0.0060 -0.0075 0.2175)
+(-0.0060 -0.0045 0.2175)
+(-0.0030 -0.0045 0.2175)
+(0.0000 -0.0045 0.2175)
+(0.0030 -0.0045 0.2175)
+(0.0060 -0.0045 0.2175)
+(-0.0060 -0.0015 0.2175)
+(-0.0030 -0.0015 0.2175)
+(0.0000 -0.0015 0.2175)
+(0.0030 -0.0015 0.2175)
+(0.0060 -0.0015 0.2175)
+(-0.0060 0.0015 0.2175)
+(-0.0030 0.0015 0.2175)
+(0.0000 0.0015 0.2175)
+(0.0030 0.0015 0.2175)
+(0.0060 0.0015 0.2175)
+(-0.0060 0.0045 0.2175)
+(-0.0030 0.0045 0.2175)
+(0.0000 0.0045 0.2175)
+(0.0030 0.0045 0.2175)
+(0.0060 0.0045 0.2175)
+(-0.0060 0.0075 0.2175)
+(-0.0030 0.0075 0.2175)
+(0.0000 0.0075 0.2175)
+(0.0030 0.0075 0.2175)
+(0.0060 0.0075 0.2175)
+(-0.0060 0.0105 0.2175)
+(-0.0030 0.0105 0.2175)
+(0.0000 0.0105 0.2175)
+(0.0030 0.0105 0.2175)
+(0.0060 0.0105 0.2175)
+(-0.0060 0.0135 0.2175)
+(-0.0030 0.0135 0.2175)
+(0.0000 0.0135 0.2175)
+(0.0030 0.0135 0.2175)
+(0.0060 0.0135 0.2175)
+(-0.0060 0.0165 0.2175)
+(-0.0030 0.0165 0.2175)
+(0.0000 0.0165 0.2175)
+(0.0030 0.0165 0.2175)
+(0.0060 0.0165 0.2175)
+(-0.0060 0.0195 0.2175)
+(-0.0030 0.0195 0.2175)
+(0.0000 0.0195 0.2175)
+(0.0030 0.0195 0.2175)
+(0.0060 0.0195 0.2175)
+(-0.0060 0.0225 0.2175)
+(-0.0030 0.0225 0.2175)
+(0.0000 0.0225 0.2175)
+(0.0030 0.0225 0.2175)
+(0.0060 0.0225 0.2175)
+(-0.0060 0.0255 0.2175)
+(-0.0030 0.0255 0.2175)
+(0.0000 0.0255 0.2175)
+(0.0030 0.0255 0.2175)
+(0.0060 0.0255 0.2175)
+(-0.0060 0.0285 0.2175)
+(-0.0030 0.0285 0.2175)
+(0.0000 0.0285 0.2175)
+(0.0030 0.0285 0.2175)
+(0.0060 0.0285 0.2175)
+(-0.0060 0.0315 0.2175)
+(-0.0030 0.0315 0.2175)
+(0.0000 0.0315 0.2175)
+(0.0030 0.0315 0.2175)
+(0.0060 0.0315 0.2175)
+(-0.0060 0.0345 0.2175)
+(-0.0030 0.0345 0.2175)
+(0.0000 0.0345 0.2175)
+(0.0030 0.0345 0.2175)
+(0.0060 0.0345 0.2175)
+(-0.0060 0.0375 0.2175)
+(-0.0030 0.0375 0.2175)
+(0.0000 0.0375 0.2175)
+(0.0030 0.0375 0.2175)
+(0.0060 0.0375 0.2175)
+(-0.0060 0.0405 0.2175)
+(-0.0030 0.0405 0.2175)
+(0.0000 0.0405 0.2175)
+(0.0030 0.0405 0.2175)
+(0.0060 0.0405 0.2175)
+(-0.0060 0.0435 0.2175)
+(-0.0030 0.0435 0.2175)
+(0.0000 0.0435 0.2175)
+(0.0030 0.0435 0.2175)
+(0.0060 0.0435 0.2175)
+(-0.0060 0.0465 0.2175)
+(-0.0030 0.0465 0.2175)
+(0.0000 0.0465 0.2175)
+(0.0030 0.0465 0.2175)
+(0.0060 0.0465 0.2175)
+(-0.0060 0.0495 0.2175)
+(-0.0030 0.0495 0.2175)
+(0.0000 0.0495 0.2175)
+(0.0030 0.0495 0.2175)
+(0.0060 0.0495 0.2175)
+(-0.0060 0.0525 0.2175)
+(-0.0030 0.0525 0.2175)
+(0.0000 0.0525 0.2175)
+(0.0030 0.0525 0.2175)
+(0.0060 0.0525 0.2175)
+(-0.0060 0.0555 0.2175)
+(-0.0030 0.0555 0.2175)
+(0.0000 0.0555 0.2175)
+(0.0030 0.0555 0.2175)
+(0.0060 0.0555 0.2175)
+(-0.0060 0.0585 0.2175)
+(-0.0030 0.0585 0.2175)
+(0.0000 0.0585 0.2175)
+(0.0030 0.0585 0.2175)
+(0.0060 0.0585 0.2175)
+(-0.0060 0.0615 0.2175)
+(-0.0030 0.0615 0.2175)
+(0.0000 0.0615 0.2175)
+(0.0030 0.0615 0.2175)
+(0.0060 0.0615 0.2175)
+(-0.0060 0.0645 0.2175)
+(-0.0030 0.0645 0.2175)
+(0.0000 0.0645 0.2175)
+(0.0030 0.0645 0.2175)
+(0.0060 0.0645 0.2175)
+(-0.0060 0.0675 0.2175)
+(-0.0030 0.0675 0.2175)
+(0.0000 0.0675 0.2175)
+(0.0030 0.0675 0.2175)
+(0.0060 0.0675 0.2175)
+(-0.0060 0.0705 0.2175)
+(-0.0030 0.0705 0.2175)
+(0.0000 0.0705 0.2175)
+(0.0030 0.0705 0.2175)
+(0.0060 0.0705 0.2175)
+(-0.0060 0.0735 0.2175)
+(-0.0030 0.0735 0.2175)
+(0.0000 0.0735 0.2175)
+(0.0030 0.0735 0.2175)
+(0.0060 0.0735 0.2175)
+(-0.0060 -0.0735 0.2205)
+(-0.0030 -0.0735 0.2205)
+(0.0000 -0.0735 0.2205)
+(0.0030 -0.0735 0.2205)
+(0.0060 -0.0735 0.2205)
+(-0.0060 -0.0705 0.2205)
+(-0.0030 -0.0705 0.2205)
+(0.0000 -0.0705 0.2205)
+(0.0030 -0.0705 0.2205)
+(0.0060 -0.0705 0.2205)
+(-0.0060 -0.0675 0.2205)
+(-0.0030 -0.0675 0.2205)
+(0.0000 -0.0675 0.2205)
+(0.0030 -0.0675 0.2205)
+(0.0060 -0.0675 0.2205)
+(-0.0060 -0.0645 0.2205)
+(-0.0030 -0.0645 0.2205)
+(0.0000 -0.0645 0.2205)
+(0.0030 -0.0645 0.2205)
+(0.0060 -0.0645 0.2205)
+(-0.0060 -0.0615 0.2205)
+(-0.0030 -0.0615 0.2205)
+(0.0000 -0.0615 0.2205)
+(0.0030 -0.0615 0.2205)
+(0.0060 -0.0615 0.2205)
+(-0.0060 -0.0585 0.2205)
+(-0.0030 -0.0585 0.2205)
+(0.0000 -0.0585 0.2205)
+(0.0030 -0.0585 0.2205)
+(0.0060 -0.0585 0.2205)
+(-0.0060 -0.0555 0.2205)
+(-0.0030 -0.0555 0.2205)
+(0.0000 -0.0555 0.2205)
+(0.0030 -0.0555 0.2205)
+(0.0060 -0.0555 0.2205)
+(-0.0060 -0.0525 0.2205)
+(-0.0030 -0.0525 0.2205)
+(0.0000 -0.0525 0.2205)
+(0.0030 -0.0525 0.2205)
+(0.0060 -0.0525 0.2205)
+(-0.0060 -0.0495 0.2205)
+(-0.0030 -0.0495 0.2205)
+(0.0000 -0.0495 0.2205)
+(0.0030 -0.0495 0.2205)
+(0.0060 -0.0495 0.2205)
+(-0.0060 -0.0465 0.2205)
+(-0.0030 -0.0465 0.2205)
+(0.0000 -0.0465 0.2205)
+(0.0030 -0.0465 0.2205)
+(0.0060 -0.0465 0.2205)
+(-0.0060 -0.0435 0.2205)
+(-0.0030 -0.0435 0.2205)
+(0.0000 -0.0435 0.2205)
+(0.0030 -0.0435 0.2205)
+(0.0060 -0.0435 0.2205)
+(-0.0060 -0.0405 0.2205)
+(-0.0030 -0.0405 0.2205)
+(0.0000 -0.0405 0.2205)
+(0.0030 -0.0405 0.2205)
+(0.0060 -0.0405 0.2205)
+(-0.0060 -0.0375 0.2205)
+(-0.0030 -0.0375 0.2205)
+(0.0000 -0.0375 0.2205)
+(0.0030 -0.0375 0.2205)
+(0.0060 -0.0375 0.2205)
+(-0.0060 -0.0345 0.2205)
+(-0.0030 -0.0345 0.2205)
+(0.0000 -0.0345 0.2205)
+(0.0030 -0.0345 0.2205)
+(0.0060 -0.0345 0.2205)
+(-0.0060 -0.0315 0.2205)
+(-0.0030 -0.0315 0.2205)
+(0.0000 -0.0315 0.2205)
+(0.0030 -0.0315 0.2205)
+(0.0060 -0.0315 0.2205)
+(-0.0060 -0.0285 0.2205)
+(-0.0030 -0.0285 0.2205)
+(0.0000 -0.0285 0.2205)
+(0.0030 -0.0285 0.2205)
+(0.0060 -0.0285 0.2205)
+(-0.0060 -0.0255 0.2205)
+(-0.0030 -0.0255 0.2205)
+(0.0000 -0.0255 0.2205)
+(0.0030 -0.0255 0.2205)
+(0.0060 -0.0255 0.2205)
+(-0.0060 -0.0225 0.2205)
+(-0.0030 -0.0225 0.2205)
+(0.0000 -0.0225 0.2205)
+(0.0030 -0.0225 0.2205)
+(0.0060 -0.0225 0.2205)
+(-0.0060 -0.0195 0.2205)
+(-0.0030 -0.0195 0.2205)
+(0.0000 -0.0195 0.2205)
+(0.0030 -0.0195 0.2205)
+(0.0060 -0.0195 0.2205)
+(-0.0060 -0.0165 0.2205)
+(-0.0030 -0.0165 0.2205)
+(0.0000 -0.0165 0.2205)
+(0.0030 -0.0165 0.2205)
+(0.0060 -0.0165 0.2205)
+(-0.0060 -0.0135 0.2205)
+(-0.0030 -0.0135 0.2205)
+(0.0000 -0.0135 0.2205)
+(0.0030 -0.0135 0.2205)
+(0.0060 -0.0135 0.2205)
+(-0.0060 -0.0105 0.2205)
+(-0.0030 -0.0105 0.2205)
+(0.0000 -0.0105 0.2205)
+(0.0030 -0.0105 0.2205)
+(0.0060 -0.0105 0.2205)
+(-0.0060 -0.0075 0.2205)
+(-0.0030 -0.0075 0.2205)
+(0.0000 -0.0075 0.2205)
+(0.0030 -0.0075 0.2205)
+(0.0060 -0.0075 0.2205)
+(-0.0060 -0.0045 0.2205)
+(-0.0030 -0.0045 0.2205)
+(0.0000 -0.0045 0.2205)
+(0.0030 -0.0045 0.2205)
+(0.0060 -0.0045 0.2205)
+(-0.0060 -0.0015 0.2205)
+(-0.0030 -0.0015 0.2205)
+(0.0000 -0.0015 0.2205)
+(0.0030 -0.0015 0.2205)
+(0.0060 -0.0015 0.2205)
+(-0.0060 0.0015 0.2205)
+(-0.0030 0.0015 0.2205)
+(0.0000 0.0015 0.2205)
+(0.0030 0.0015 0.2205)
+(0.0060 0.0015 0.2205)
+(-0.0060 0.0045 0.2205)
+(-0.0030 0.0045 0.2205)
+(0.0000 0.0045 0.2205)
+(0.0030 0.0045 0.2205)
+(0.0060 0.0045 0.2205)
+(-0.0060 0.0075 0.2205)
+(-0.0030 0.0075 0.2205)
+(0.0000 0.0075 0.2205)
+(0.0030 0.0075 0.2205)
+(0.0060 0.0075 0.2205)
+(-0.0060 0.0105 0.2205)
+(-0.0030 0.0105 0.2205)
+(0.0000 0.0105 0.2205)
+(0.0030 0.0105 0.2205)
+(0.0060 0.0105 0.2205)
+(-0.0060 0.0135 0.2205)
+(-0.0030 0.0135 0.2205)
+(0.0000 0.0135 0.2205)
+(0.0030 0.0135 0.2205)
+(0.0060 0.0135 0.2205)
+(-0.0060 0.0165 0.2205)
+(-0.0030 0.0165 0.2205)
+(0.0000 0.0165 0.2205)
+(0.0030 0.0165 0.2205)
+(0.0060 0.0165 0.2205)
+(-0.0060 0.0195 0.2205)
+(-0.0030 0.0195 0.2205)
+(0.0000 0.0195 0.2205)
+(0.0030 0.0195 0.2205)
+(0.0060 0.0195 0.2205)
+(-0.0060 0.0225 0.2205)
+(-0.0030 0.0225 0.2205)
+(0.0000 0.0225 0.2205)
+(0.0030 0.0225 0.2205)
+(0.0060 0.0225 0.2205)
+(-0.0060 0.0255 0.2205)
+(-0.0030 0.0255 0.2205)
+(0.0000 0.0255 0.2205)
+(0.0030 0.0255 0.2205)
+(0.0060 0.0255 0.2205)
+(-0.0060 0.0285 0.2205)
+(-0.0030 0.0285 0.2205)
+(0.0000 0.0285 0.2205)
+(0.0030 0.0285 0.2205)
+(0.0060 0.0285 0.2205)
+(-0.0060 0.0315 0.2205)
+(-0.0030 0.0315 0.2205)
+(0.0000 0.0315 0.2205)
+(0.0030 0.0315 0.2205)
+(0.0060 0.0315 0.2205)
+(-0.0060 0.0345 0.2205)
+(-0.0030 0.0345 0.2205)
+(0.0000 0.0345 0.2205)
+(0.0030 0.0345 0.2205)
+(0.0060 0.0345 0.2205)
+(-0.0060 0.0375 0.2205)
+(-0.0030 0.0375 0.2205)
+(0.0000 0.0375 0.2205)
+(0.0030 0.0375 0.2205)
+(0.0060 0.0375 0.2205)
+(-0.0060 0.0405 0.2205)
+(-0.0030 0.0405 0.2205)
+(0.0000 0.0405 0.2205)
+(0.0030 0.0405 0.2205)
+(0.0060 0.0405 0.2205)
+(-0.0060 0.0435 0.2205)
+(-0.0030 0.0435 0.2205)
+(0.0000 0.0435 0.2205)
+(0.0030 0.0435 0.2205)
+(0.0060 0.0435 0.2205)
+(-0.0060 0.0465 0.2205)
+(-0.0030 0.0465 0.2205)
+(0.0000 0.0465 0.2205)
+(0.0030 0.0465 0.2205)
+(0.0060 0.0465 0.2205)
+(-0.0060 0.0495 0.2205)
+(-0.0030 0.0495 0.2205)
+(0.0000 0.0495 0.2205)
+(0.0030 0.0495 0.2205)
+(0.0060 0.0495 0.2205)
+(-0.0060 0.0525 0.2205)
+(-0.0030 0.0525 0.2205)
+(0.0000 0.0525 0.2205)
+(0.0030 0.0525 0.2205)
+(0.0060 0.0525 0.2205)
+(-0.0060 0.0555 0.2205)
+(-0.0030 0.0555 0.2205)
+(0.0000 0.0555 0.2205)
+(0.0030 0.0555 0.2205)
+(0.0060 0.0555 0.2205)
+(-0.0060 0.0585 0.2205)
+(-0.0030 0.0585 0.2205)
+(0.0000 0.0585 0.2205)
+(0.0030 0.0585 0.2205)
+(0.0060 0.0585 0.2205)
+(-0.0060 0.0615 0.2205)
+(-0.0030 0.0615 0.2205)
+(0.0000 0.0615 0.2205)
+(0.0030 0.0615 0.2205)
+(0.0060 0.0615 0.2205)
+(-0.0060 0.0645 0.2205)
+(-0.0030 0.0645 0.2205)
+(0.0000 0.0645 0.2205)
+(0.0030 0.0645 0.2205)
+(0.0060 0.0645 0.2205)
+(-0.0060 0.0675 0.2205)
+(-0.0030 0.0675 0.2205)
+(0.0000 0.0675 0.2205)
+(0.0030 0.0675 0.2205)
+(0.0060 0.0675 0.2205)
+(-0.0060 0.0705 0.2205)
+(-0.0030 0.0705 0.2205)
+(0.0000 0.0705 0.2205)
+(0.0030 0.0705 0.2205)
+(0.0060 0.0705 0.2205)
+(-0.0060 0.0735 0.2205)
+(-0.0030 0.0735 0.2205)
+(0.0000 0.0735 0.2205)
+(0.0030 0.0735 0.2205)
+(0.0060 0.0735 0.2205)
+(-0.0060 -0.0735 0.2235)
+(-0.0030 -0.0735 0.2235)
+(0.0000 -0.0735 0.2235)
+(0.0030 -0.0735 0.2235)
+(0.0060 -0.0735 0.2235)
+(-0.0060 -0.0705 0.2235)
+(-0.0030 -0.0705 0.2235)
+(0.0000 -0.0705 0.2235)
+(0.0030 -0.0705 0.2235)
+(0.0060 -0.0705 0.2235)
+(-0.0060 -0.0675 0.2235)
+(-0.0030 -0.0675 0.2235)
+(0.0000 -0.0675 0.2235)
+(0.0030 -0.0675 0.2235)
+(0.0060 -0.0675 0.2235)
+(-0.0060 -0.0645 0.2235)
+(-0.0030 -0.0645 0.2235)
+(0.0000 -0.0645 0.2235)
+(0.0030 -0.0645 0.2235)
+(0.0060 -0.0645 0.2235)
+(-0.0060 -0.0615 0.2235)
+(-0.0030 -0.0615 0.2235)
+(0.0000 -0.0615 0.2235)
+(0.0030 -0.0615 0.2235)
+(0.0060 -0.0615 0.2235)
+(-0.0060 -0.0585 0.2235)
+(-0.0030 -0.0585 0.2235)
+(0.0000 -0.0585 0.2235)
+(0.0030 -0.0585 0.2235)
+(0.0060 -0.0585 0.2235)
+(-0.0060 -0.0555 0.2235)
+(-0.0030 -0.0555 0.2235)
+(0.0000 -0.0555 0.2235)
+(0.0030 -0.0555 0.2235)
+(0.0060 -0.0555 0.2235)
+(-0.0060 -0.0525 0.2235)
+(-0.0030 -0.0525 0.2235)
+(0.0000 -0.0525 0.2235)
+(0.0030 -0.0525 0.2235)
+(0.0060 -0.0525 0.2235)
+(-0.0060 -0.0495 0.2235)
+(-0.0030 -0.0495 0.2235)
+(0.0000 -0.0495 0.2235)
+(0.0030 -0.0495 0.2235)
+(0.0060 -0.0495 0.2235)
+(-0.0060 -0.0465 0.2235)
+(-0.0030 -0.0465 0.2235)
+(0.0000 -0.0465 0.2235)
+(0.0030 -0.0465 0.2235)
+(0.0060 -0.0465 0.2235)
+(-0.0060 -0.0435 0.2235)
+(-0.0030 -0.0435 0.2235)
+(0.0000 -0.0435 0.2235)
+(0.0030 -0.0435 0.2235)
+(0.0060 -0.0435 0.2235)
+(-0.0060 -0.0405 0.2235)
+(-0.0030 -0.0405 0.2235)
+(0.0000 -0.0405 0.2235)
+(0.0030 -0.0405 0.2235)
+(0.0060 -0.0405 0.2235)
+(-0.0060 -0.0375 0.2235)
+(-0.0030 -0.0375 0.2235)
+(0.0000 -0.0375 0.2235)
+(0.0030 -0.0375 0.2235)
+(0.0060 -0.0375 0.2235)
+(-0.0060 -0.0345 0.2235)
+(-0.0030 -0.0345 0.2235)
+(0.0000 -0.0345 0.2235)
+(0.0030 -0.0345 0.2235)
+(0.0060 -0.0345 0.2235)
+(-0.0060 -0.0315 0.2235)
+(-0.0030 -0.0315 0.2235)
+(0.0000 -0.0315 0.2235)
+(0.0030 -0.0315 0.2235)
+(0.0060 -0.0315 0.2235)
+(-0.0060 -0.0285 0.2235)
+(-0.0030 -0.0285 0.2235)
+(0.0000 -0.0285 0.2235)
+(0.0030 -0.0285 0.2235)
+(0.0060 -0.0285 0.2235)
+(-0.0060 -0.0255 0.2235)
+(-0.0030 -0.0255 0.2235)
+(0.0000 -0.0255 0.2235)
+(0.0030 -0.0255 0.2235)
+(0.0060 -0.0255 0.2235)
+(-0.0060 -0.0225 0.2235)
+(-0.0030 -0.0225 0.2235)
+(0.0000 -0.0225 0.2235)
+(0.0030 -0.0225 0.2235)
+(0.0060 -0.0225 0.2235)
+(-0.0060 -0.0195 0.2235)
+(-0.0030 -0.0195 0.2235)
+(0.0000 -0.0195 0.2235)
+(0.0030 -0.0195 0.2235)
+(0.0060 -0.0195 0.2235)
+(-0.0060 -0.0165 0.2235)
+(-0.0030 -0.0165 0.2235)
+(0.0000 -0.0165 0.2235)
+(0.0030 -0.0165 0.2235)
+(0.0060 -0.0165 0.2235)
+(-0.0060 -0.0135 0.2235)
+(-0.0030 -0.0135 0.2235)
+(0.0000 -0.0135 0.2235)
+(0.0030 -0.0135 0.2235)
+(0.0060 -0.0135 0.2235)
+(-0.0060 -0.0105 0.2235)
+(-0.0030 -0.0105 0.2235)
+(0.0000 -0.0105 0.2235)
+(0.0030 -0.0105 0.2235)
+(0.0060 -0.0105 0.2235)
+(-0.0060 -0.0075 0.2235)
+(-0.0030 -0.0075 0.2235)
+(0.0000 -0.0075 0.2235)
+(0.0030 -0.0075 0.2235)
+(0.0060 -0.0075 0.2235)
+(-0.0060 -0.0045 0.2235)
+(-0.0030 -0.0045 0.2235)
+(0.0000 -0.0045 0.2235)
+(0.0030 -0.0045 0.2235)
+(0.0060 -0.0045 0.2235)
+(-0.0060 -0.0015 0.2235)
+(-0.0030 -0.0015 0.2235)
+(0.0000 -0.0015 0.2235)
+(0.0030 -0.0015 0.2235)
+(0.0060 -0.0015 0.2235)
+(-0.0060 0.0015 0.2235)
+(-0.0030 0.0015 0.2235)
+(0.0000 0.0015 0.2235)
+(0.0030 0.0015 0.2235)
+(0.0060 0.0015 0.2235)
+(-0.0060 0.0045 0.2235)
+(-0.0030 0.0045 0.2235)
+(0.0000 0.0045 0.2235)
+(0.0030 0.0045 0.2235)
+(0.0060 0.0045 0.2235)
+(-0.0060 0.0075 0.2235)
+(-0.0030 0.0075 0.2235)
+(0.0000 0.0075 0.2235)
+(0.0030 0.0075 0.2235)
+(0.0060 0.0075 0.2235)
+(-0.0060 0.0105 0.2235)
+(-0.0030 0.0105 0.2235)
+(0.0000 0.0105 0.2235)
+(0.0030 0.0105 0.2235)
+(0.0060 0.0105 0.2235)
+(-0.0060 0.0135 0.2235)
+(-0.0030 0.0135 0.2235)
+(0.0000 0.0135 0.2235)
+(0.0030 0.0135 0.2235)
+(0.0060 0.0135 0.2235)
+(-0.0060 0.0165 0.2235)
+(-0.0030 0.0165 0.2235)
+(0.0000 0.0165 0.2235)
+(0.0030 0.0165 0.2235)
+(0.0060 0.0165 0.2235)
+(-0.0060 0.0195 0.2235)
+(-0.0030 0.0195 0.2235)
+(0.0000 0.0195 0.2235)
+(0.0030 0.0195 0.2235)
+(0.0060 0.0195 0.2235)
+(-0.0060 0.0225 0.2235)
+(-0.0030 0.0225 0.2235)
+(0.0000 0.0225 0.2235)
+(0.0030 0.0225 0.2235)
+(0.0060 0.0225 0.2235)
+(-0.0060 0.0255 0.2235)
+(-0.0030 0.0255 0.2235)
+(0.0000 0.0255 0.2235)
+(0.0030 0.0255 0.2235)
+(0.0060 0.0255 0.2235)
+(-0.0060 0.0285 0.2235)
+(-0.0030 0.0285 0.2235)
+(0.0000 0.0285 0.2235)
+(0.0030 0.0285 0.2235)
+(0.0060 0.0285 0.2235)
+(-0.0060 0.0315 0.2235)
+(-0.0030 0.0315 0.2235)
+(0.0000 0.0315 0.2235)
+(0.0030 0.0315 0.2235)
+(0.0060 0.0315 0.2235)
+(-0.0060 0.0345 0.2235)
+(-0.0030 0.0345 0.2235)
+(0.0000 0.0345 0.2235)
+(0.0030 0.0345 0.2235)
+(0.0060 0.0345 0.2235)
+(-0.0060 0.0375 0.2235)
+(-0.0030 0.0375 0.2235)
+(0.0000 0.0375 0.2235)
+(0.0030 0.0375 0.2235)
+(0.0060 0.0375 0.2235)
+(-0.0060 0.0405 0.2235)
+(-0.0030 0.0405 0.2235)
+(0.0000 0.0405 0.2235)
+(0.0030 0.0405 0.2235)
+(0.0060 0.0405 0.2235)
+(-0.0060 0.0435 0.2235)
+(-0.0030 0.0435 0.2235)
+(0.0000 0.0435 0.2235)
+(0.0030 0.0435 0.2235)
+(0.0060 0.0435 0.2235)
+(-0.0060 0.0465 0.2235)
+(-0.0030 0.0465 0.2235)
+(0.0000 0.0465 0.2235)
+(0.0030 0.0465 0.2235)
+(0.0060 0.0465 0.2235)
+(-0.0060 0.0495 0.2235)
+(-0.0030 0.0495 0.2235)
+(0.0000 0.0495 0.2235)
+(0.0030 0.0495 0.2235)
+(0.0060 0.0495 0.2235)
+(-0.0060 0.0525 0.2235)
+(-0.0030 0.0525 0.2235)
+(0.0000 0.0525 0.2235)
+(0.0030 0.0525 0.2235)
+(0.0060 0.0525 0.2235)
+(-0.0060 0.0555 0.2235)
+(-0.0030 0.0555 0.2235)
+(0.0000 0.0555 0.2235)
+(0.0030 0.0555 0.2235)
+(0.0060 0.0555 0.2235)
+(-0.0060 0.0585 0.2235)
+(-0.0030 0.0585 0.2235)
+(0.0000 0.0585 0.2235)
+(0.0030 0.0585 0.2235)
+(0.0060 0.0585 0.2235)
+(-0.0060 0.0615 0.2235)
+(-0.0030 0.0615 0.2235)
+(0.0000 0.0615 0.2235)
+(0.0030 0.0615 0.2235)
+(0.0060 0.0615 0.2235)
+(-0.0060 0.0645 0.2235)
+(-0.0030 0.0645 0.2235)
+(0.0000 0.0645 0.2235)
+(0.0030 0.0645 0.2235)
+(0.0060 0.0645 0.2235)
+(-0.0060 0.0675 0.2235)
+(-0.0030 0.0675 0.2235)
+(0.0000 0.0675 0.2235)
+(0.0030 0.0675 0.2235)
+(0.0060 0.0675 0.2235)
+(-0.0060 0.0705 0.2235)
+(-0.0030 0.0705 0.2235)
+(0.0000 0.0705 0.2235)
+(0.0030 0.0705 0.2235)
+(0.0060 0.0705 0.2235)
+(-0.0060 0.0735 0.2235)
+(-0.0030 0.0735 0.2235)
+(0.0000 0.0735 0.2235)
+(0.0030 0.0735 0.2235)
+(0.0060 0.0735 0.2235)
+(-0.0060 -0.0735 0.2265)
+(-0.0030 -0.0735 0.2265)
+(0.0000 -0.0735 0.2265)
+(0.0030 -0.0735 0.2265)
+(0.0060 -0.0735 0.2265)
+(-0.0060 -0.0705 0.2265)
+(-0.0030 -0.0705 0.2265)
+(0.0000 -0.0705 0.2265)
+(0.0030 -0.0705 0.2265)
+(0.0060 -0.0705 0.2265)
+(-0.0060 -0.0675 0.2265)
+(-0.0030 -0.0675 0.2265)
+(0.0000 -0.0675 0.2265)
+(0.0030 -0.0675 0.2265)
+(0.0060 -0.0675 0.2265)
+(-0.0060 -0.0645 0.2265)
+(-0.0030 -0.0645 0.2265)
+(0.0000 -0.0645 0.2265)
+(0.0030 -0.0645 0.2265)
+(0.0060 -0.0645 0.2265)
+(-0.0060 -0.0615 0.2265)
+(-0.0030 -0.0615 0.2265)
+(0.0000 -0.0615 0.2265)
+(0.0030 -0.0615 0.2265)
+(0.0060 -0.0615 0.2265)
+(-0.0060 -0.0585 0.2265)
+(-0.0030 -0.0585 0.2265)
+(0.0000 -0.0585 0.2265)
+(0.0030 -0.0585 0.2265)
+(0.0060 -0.0585 0.2265)
+(-0.0060 -0.0555 0.2265)
+(-0.0030 -0.0555 0.2265)
+(0.0000 -0.0555 0.2265)
+(0.0030 -0.0555 0.2265)
+(0.0060 -0.0555 0.2265)
+(-0.0060 -0.0525 0.2265)
+(-0.0030 -0.0525 0.2265)
+(0.0000 -0.0525 0.2265)
+(0.0030 -0.0525 0.2265)
+(0.0060 -0.0525 0.2265)
+(-0.0060 -0.0495 0.2265)
+(-0.0030 -0.0495 0.2265)
+(0.0000 -0.0495 0.2265)
+(0.0030 -0.0495 0.2265)
+(0.0060 -0.0495 0.2265)
+(-0.0060 -0.0465 0.2265)
+(-0.0030 -0.0465 0.2265)
+(0.0000 -0.0465 0.2265)
+(0.0030 -0.0465 0.2265)
+(0.0060 -0.0465 0.2265)
+(-0.0060 -0.0435 0.2265)
+(-0.0030 -0.0435 0.2265)
+(0.0000 -0.0435 0.2265)
+(0.0030 -0.0435 0.2265)
+(0.0060 -0.0435 0.2265)
+(-0.0060 -0.0405 0.2265)
+(-0.0030 -0.0405 0.2265)
+(0.0000 -0.0405 0.2265)
+(0.0030 -0.0405 0.2265)
+(0.0060 -0.0405 0.2265)
+(-0.0060 -0.0375 0.2265)
+(-0.0030 -0.0375 0.2265)
+(0.0000 -0.0375 0.2265)
+(0.0030 -0.0375 0.2265)
+(0.0060 -0.0375 0.2265)
+(-0.0060 -0.0345 0.2265)
+(-0.0030 -0.0345 0.2265)
+(0.0000 -0.0345 0.2265)
+(0.0030 -0.0345 0.2265)
+(0.0060 -0.0345 0.2265)
+(-0.0060 -0.0315 0.2265)
+(-0.0030 -0.0315 0.2265)
+(0.0000 -0.0315 0.2265)
+(0.0030 -0.0315 0.2265)
+(0.0060 -0.0315 0.2265)
+(-0.0060 -0.0285 0.2265)
+(-0.0030 -0.0285 0.2265)
+(0.0000 -0.0285 0.2265)
+(0.0030 -0.0285 0.2265)
+(0.0060 -0.0285 0.2265)
+(-0.0060 -0.0255 0.2265)
+(-0.0030 -0.0255 0.2265)
+(0.0000 -0.0255 0.2265)
+(0.0030 -0.0255 0.2265)
+(0.0060 -0.0255 0.2265)
+(-0.0060 -0.0225 0.2265)
+(-0.0030 -0.0225 0.2265)
+(0.0000 -0.0225 0.2265)
+(0.0030 -0.0225 0.2265)
+(0.0060 -0.0225 0.2265)
+(-0.0060 -0.0195 0.2265)
+(-0.0030 -0.0195 0.2265)
+(0.0000 -0.0195 0.2265)
+(0.0030 -0.0195 0.2265)
+(0.0060 -0.0195 0.2265)
+(-0.0060 -0.0165 0.2265)
+(-0.0030 -0.0165 0.2265)
+(0.0000 -0.0165 0.2265)
+(0.0030 -0.0165 0.2265)
+(0.0060 -0.0165 0.2265)
+(-0.0060 -0.0135 0.2265)
+(-0.0030 -0.0135 0.2265)
+(0.0000 -0.0135 0.2265)
+(0.0030 -0.0135 0.2265)
+(0.0060 -0.0135 0.2265)
+(-0.0060 -0.0105 0.2265)
+(-0.0030 -0.0105 0.2265)
+(0.0000 -0.0105 0.2265)
+(0.0030 -0.0105 0.2265)
+(0.0060 -0.0105 0.2265)
+(-0.0060 -0.0075 0.2265)
+(-0.0030 -0.0075 0.2265)
+(0.0000 -0.0075 0.2265)
+(0.0030 -0.0075 0.2265)
+(0.0060 -0.0075 0.2265)
+(-0.0060 -0.0045 0.2265)
+(-0.0030 -0.0045 0.2265)
+(0.0000 -0.0045 0.2265)
+(0.0030 -0.0045 0.2265)
+(0.0060 -0.0045 0.2265)
+(-0.0060 -0.0015 0.2265)
+(-0.0030 -0.0015 0.2265)
+(0.0000 -0.0015 0.2265)
+(0.0030 -0.0015 0.2265)
+(0.0060 -0.0015 0.2265)
+(-0.0060 0.0015 0.2265)
+(-0.0030 0.0015 0.2265)
+(0.0000 0.0015 0.2265)
+(0.0030 0.0015 0.2265)
+(0.0060 0.0015 0.2265)
+(-0.0060 0.0045 0.2265)
+(-0.0030 0.0045 0.2265)
+(0.0000 0.0045 0.2265)
+(0.0030 0.0045 0.2265)
+(0.0060 0.0045 0.2265)
+(-0.0060 0.0075 0.2265)
+(-0.0030 0.0075 0.2265)
+(0.0000 0.0075 0.2265)
+(0.0030 0.0075 0.2265)
+(0.0060 0.0075 0.2265)
+(-0.0060 0.0105 0.2265)
+(-0.0030 0.0105 0.2265)
+(0.0000 0.0105 0.2265)
+(0.0030 0.0105 0.2265)
+(0.0060 0.0105 0.2265)
+(-0.0060 0.0135 0.2265)
+(-0.0030 0.0135 0.2265)
+(0.0000 0.0135 0.2265)
+(0.0030 0.0135 0.2265)
+(0.0060 0.0135 0.2265)
+(-0.0060 0.0165 0.2265)
+(-0.0030 0.0165 0.2265)
+(0.0000 0.0165 0.2265)
+(0.0030 0.0165 0.2265)
+(0.0060 0.0165 0.2265)
+(-0.0060 0.0195 0.2265)
+(-0.0030 0.0195 0.2265)
+(0.0000 0.0195 0.2265)
+(0.0030 0.0195 0.2265)
+(0.0060 0.0195 0.2265)
+(-0.0060 0.0225 0.2265)
+(-0.0030 0.0225 0.2265)
+(0.0000 0.0225 0.2265)
+(0.0030 0.0225 0.2265)
+(0.0060 0.0225 0.2265)
+(-0.0060 0.0255 0.2265)
+(-0.0030 0.0255 0.2265)
+(0.0000 0.0255 0.2265)
+(0.0030 0.0255 0.2265)
+(0.0060 0.0255 0.2265)
+(-0.0060 0.0285 0.2265)
+(-0.0030 0.0285 0.2265)
+(0.0000 0.0285 0.2265)
+(0.0030 0.0285 0.2265)
+(0.0060 0.0285 0.2265)
+(-0.0060 0.0315 0.2265)
+(-0.0030 0.0315 0.2265)
+(0.0000 0.0315 0.2265)
+(0.0030 0.0315 0.2265)
+(0.0060 0.0315 0.2265)
+(-0.0060 0.0345 0.2265)
+(-0.0030 0.0345 0.2265)
+(0.0000 0.0345 0.2265)
+(0.0030 0.0345 0.2265)
+(0.0060 0.0345 0.2265)
+(-0.0060 0.0375 0.2265)
+(-0.0030 0.0375 0.2265)
+(0.0000 0.0375 0.2265)
+(0.0030 0.0375 0.2265)
+(0.0060 0.0375 0.2265)
+(-0.0060 0.0405 0.2265)
+(-0.0030 0.0405 0.2265)
+(0.0000 0.0405 0.2265)
+(0.0030 0.0405 0.2265)
+(0.0060 0.0405 0.2265)
+(-0.0060 0.0435 0.2265)
+(-0.0030 0.0435 0.2265)
+(0.0000 0.0435 0.2265)
+(0.0030 0.0435 0.2265)
+(0.0060 0.0435 0.2265)
+(-0.0060 0.0465 0.2265)
+(-0.0030 0.0465 0.2265)
+(0.0000 0.0465 0.2265)
+(0.0030 0.0465 0.2265)
+(0.0060 0.0465 0.2265)
+(-0.0060 0.0495 0.2265)
+(-0.0030 0.0495 0.2265)
+(0.0000 0.0495 0.2265)
+(0.0030 0.0495 0.2265)
+(0.0060 0.0495 0.2265)
+(-0.0060 0.0525 0.2265)
+(-0.0030 0.0525 0.2265)
+(0.0000 0.0525 0.2265)
+(0.0030 0.0525 0.2265)
+(0.0060 0.0525 0.2265)
+(-0.0060 0.0555 0.2265)
+(-0.0030 0.0555 0.2265)
+(0.0000 0.0555 0.2265)
+(0.0030 0.0555 0.2265)
+(0.0060 0.0555 0.2265)
+(-0.0060 0.0585 0.2265)
+(-0.0030 0.0585 0.2265)
+(0.0000 0.0585 0.2265)
+(0.0030 0.0585 0.2265)
+(0.0060 0.0585 0.2265)
+(-0.0060 0.0615 0.2265)
+(-0.0030 0.0615 0.2265)
+(0.0000 0.0615 0.2265)
+(0.0030 0.0615 0.2265)
+(0.0060 0.0615 0.2265)
+(-0.0060 0.0645 0.2265)
+(-0.0030 0.0645 0.2265)
+(0.0000 0.0645 0.2265)
+(0.0030 0.0645 0.2265)
+(0.0060 0.0645 0.2265)
+(-0.0060 0.0675 0.2265)
+(-0.0030 0.0675 0.2265)
+(0.0000 0.0675 0.2265)
+(0.0030 0.0675 0.2265)
+(0.0060 0.0675 0.2265)
+(-0.0060 0.0705 0.2265)
+(-0.0030 0.0705 0.2265)
+(0.0000 0.0705 0.2265)
+(0.0030 0.0705 0.2265)
+(0.0060 0.0705 0.2265)
+(-0.0060 0.0735 0.2265)
+(-0.0030 0.0735 0.2265)
+(0.0000 0.0735 0.2265)
+(0.0030 0.0735 0.2265)
+(0.0060 0.0735 0.2265)
+(-0.0060 -0.0735 0.2295)
+(-0.0030 -0.0735 0.2295)
+(0.0000 -0.0735 0.2295)
+(0.0030 -0.0735 0.2295)
+(0.0060 -0.0735 0.2295)
+(-0.0060 -0.0705 0.2295)
+(-0.0030 -0.0705 0.2295)
+(0.0000 -0.0705 0.2295)
+(0.0030 -0.0705 0.2295)
+(0.0060 -0.0705 0.2295)
+(-0.0060 -0.0675 0.2295)
+(-0.0030 -0.0675 0.2295)
+(0.0000 -0.0675 0.2295)
+(0.0030 -0.0675 0.2295)
+(0.0060 -0.0675 0.2295)
+(-0.0060 -0.0645 0.2295)
+(-0.0030 -0.0645 0.2295)
+(0.0000 -0.0645 0.2295)
+(0.0030 -0.0645 0.2295)
+(0.0060 -0.0645 0.2295)
+(-0.0060 -0.0615 0.2295)
+(-0.0030 -0.0615 0.2295)
+(0.0000 -0.0615 0.2295)
+(0.0030 -0.0615 0.2295)
+(0.0060 -0.0615 0.2295)
+(-0.0060 -0.0585 0.2295)
+(-0.0030 -0.0585 0.2295)
+(0.0000 -0.0585 0.2295)
+(0.0030 -0.0585 0.2295)
+(0.0060 -0.0585 0.2295)
+(-0.0060 -0.0555 0.2295)
+(-0.0030 -0.0555 0.2295)
+(0.0000 -0.0555 0.2295)
+(0.0030 -0.0555 0.2295)
+(0.0060 -0.0555 0.2295)
+(-0.0060 -0.0525 0.2295)
+(-0.0030 -0.0525 0.2295)
+(0.0000 -0.0525 0.2295)
+(0.0030 -0.0525 0.2295)
+(0.0060 -0.0525 0.2295)
+(-0.0060 -0.0495 0.2295)
+(-0.0030 -0.0495 0.2295)
+(0.0000 -0.0495 0.2295)
+(0.0030 -0.0495 0.2295)
+(0.0060 -0.0495 0.2295)
+(-0.0060 -0.0465 0.2295)
+(-0.0030 -0.0465 0.2295)
+(0.0000 -0.0465 0.2295)
+(0.0030 -0.0465 0.2295)
+(0.0060 -0.0465 0.2295)
+(-0.0060 -0.0435 0.2295)
+(-0.0030 -0.0435 0.2295)
+(0.0000 -0.0435 0.2295)
+(0.0030 -0.0435 0.2295)
+(0.0060 -0.0435 0.2295)
+(-0.0060 -0.0405 0.2295)
+(-0.0030 -0.0405 0.2295)
+(0.0000 -0.0405 0.2295)
+(0.0030 -0.0405 0.2295)
+(0.0060 -0.0405 0.2295)
+(-0.0060 -0.0375 0.2295)
+(-0.0030 -0.0375 0.2295)
+(0.0000 -0.0375 0.2295)
+(0.0030 -0.0375 0.2295)
+(0.0060 -0.0375 0.2295)
+(-0.0060 -0.0345 0.2295)
+(-0.0030 -0.0345 0.2295)
+(0.0000 -0.0345 0.2295)
+(0.0030 -0.0345 0.2295)
+(0.0060 -0.0345 0.2295)
+(-0.0060 -0.0315 0.2295)
+(-0.0030 -0.0315 0.2295)
+(0.0000 -0.0315 0.2295)
+(0.0030 -0.0315 0.2295)
+(0.0060 -0.0315 0.2295)
+(-0.0060 -0.0285 0.2295)
+(-0.0030 -0.0285 0.2295)
+(0.0000 -0.0285 0.2295)
+(0.0030 -0.0285 0.2295)
+(0.0060 -0.0285 0.2295)
+(-0.0060 -0.0255 0.2295)
+(-0.0030 -0.0255 0.2295)
+(0.0000 -0.0255 0.2295)
+(0.0030 -0.0255 0.2295)
+(0.0060 -0.0255 0.2295)
+(-0.0060 -0.0225 0.2295)
+(-0.0030 -0.0225 0.2295)
+(0.0000 -0.0225 0.2295)
+(0.0030 -0.0225 0.2295)
+(0.0060 -0.0225 0.2295)
+(-0.0060 -0.0195 0.2295)
+(-0.0030 -0.0195 0.2295)
+(0.0000 -0.0195 0.2295)
+(0.0030 -0.0195 0.2295)
+(0.0060 -0.0195 0.2295)
+(-0.0060 -0.0165 0.2295)
+(-0.0030 -0.0165 0.2295)
+(0.0000 -0.0165 0.2295)
+(0.0030 -0.0165 0.2295)
+(0.0060 -0.0165 0.2295)
+(-0.0060 -0.0135 0.2295)
+(-0.0030 -0.0135 0.2295)
+(0.0000 -0.0135 0.2295)
+(0.0030 -0.0135 0.2295)
+(0.0060 -0.0135 0.2295)
+(-0.0060 -0.0105 0.2295)
+(-0.0030 -0.0105 0.2295)
+(0.0000 -0.0105 0.2295)
+(0.0030 -0.0105 0.2295)
+(0.0060 -0.0105 0.2295)
+(-0.0060 -0.0075 0.2295)
+(-0.0030 -0.0075 0.2295)
+(0.0000 -0.0075 0.2295)
+(0.0030 -0.0075 0.2295)
+(0.0060 -0.0075 0.2295)
+(-0.0060 -0.0045 0.2295)
+(-0.0030 -0.0045 0.2295)
+(0.0000 -0.0045 0.2295)
+(0.0030 -0.0045 0.2295)
+(0.0060 -0.0045 0.2295)
+(-0.0060 -0.0015 0.2295)
+(-0.0030 -0.0015 0.2295)
+(0.0000 -0.0015 0.2295)
+(0.0030 -0.0015 0.2295)
+(0.0060 -0.0015 0.2295)
+(-0.0060 0.0015 0.2295)
+(-0.0030 0.0015 0.2295)
+(0.0000 0.0015 0.2295)
+(0.0030 0.0015 0.2295)
+(0.0060 0.0015 0.2295)
+(-0.0060 0.0045 0.2295)
+(-0.0030 0.0045 0.2295)
+(0.0000 0.0045 0.2295)
+(0.0030 0.0045 0.2295)
+(0.0060 0.0045 0.2295)
+(-0.0060 0.0075 0.2295)
+(-0.0030 0.0075 0.2295)
+(0.0000 0.0075 0.2295)
+(0.0030 0.0075 0.2295)
+(0.0060 0.0075 0.2295)
+(-0.0060 0.0105 0.2295)
+(-0.0030 0.0105 0.2295)
+(0.0000 0.0105 0.2295)
+(0.0030 0.0105 0.2295)
+(0.0060 0.0105 0.2295)
+(-0.0060 0.0135 0.2295)
+(-0.0030 0.0135 0.2295)
+(0.0000 0.0135 0.2295)
+(0.0030 0.0135 0.2295)
+(0.0060 0.0135 0.2295)
+(-0.0060 0.0165 0.2295)
+(-0.0030 0.0165 0.2295)
+(0.0000 0.0165 0.2295)
+(0.0030 0.0165 0.2295)
+(0.0060 0.0165 0.2295)
+(-0.0060 0.0195 0.2295)
+(-0.0030 0.0195 0.2295)
+(0.0000 0.0195 0.2295)
+(0.0030 0.0195 0.2295)
+(0.0060 0.0195 0.2295)
+(-0.0060 0.0225 0.2295)
+(-0.0030 0.0225 0.2295)
+(0.0000 0.0225 0.2295)
+(0.0030 0.0225 0.2295)
+(0.0060 0.0225 0.2295)
+(-0.0060 0.0255 0.2295)
+(-0.0030 0.0255 0.2295)
+(0.0000 0.0255 0.2295)
+(0.0030 0.0255 0.2295)
+(0.0060 0.0255 0.2295)
+(-0.0060 0.0285 0.2295)
+(-0.0030 0.0285 0.2295)
+(0.0000 0.0285 0.2295)
+(0.0030 0.0285 0.2295)
+(0.0060 0.0285 0.2295)
+(-0.0060 0.0315 0.2295)
+(-0.0030 0.0315 0.2295)
+(0.0000 0.0315 0.2295)
+(0.0030 0.0315 0.2295)
+(0.0060 0.0315 0.2295)
+(-0.0060 0.0345 0.2295)
+(-0.0030 0.0345 0.2295)
+(0.0000 0.0345 0.2295)
+(0.0030 0.0345 0.2295)
+(0.0060 0.0345 0.2295)
+(-0.0060 0.0375 0.2295)
+(-0.0030 0.0375 0.2295)
+(0.0000 0.0375 0.2295)
+(0.0030 0.0375 0.2295)
+(0.0060 0.0375 0.2295)
+(-0.0060 0.0405 0.2295)
+(-0.0030 0.0405 0.2295)
+(0.0000 0.0405 0.2295)
+(0.0030 0.0405 0.2295)
+(0.0060 0.0405 0.2295)
+(-0.0060 0.0435 0.2295)
+(-0.0030 0.0435 0.2295)
+(0.0000 0.0435 0.2295)
+(0.0030 0.0435 0.2295)
+(0.0060 0.0435 0.2295)
+(-0.0060 0.0465 0.2295)
+(-0.0030 0.0465 0.2295)
+(0.0000 0.0465 0.2295)
+(0.0030 0.0465 0.2295)
+(0.0060 0.0465 0.2295)
+(-0.0060 0.0495 0.2295)
+(-0.0030 0.0495 0.2295)
+(0.0000 0.0495 0.2295)
+(0.0030 0.0495 0.2295)
+(0.0060 0.0495 0.2295)
+(-0.0060 0.0525 0.2295)
+(-0.0030 0.0525 0.2295)
+(0.0000 0.0525 0.2295)
+(0.0030 0.0525 0.2295)
+(0.0060 0.0525 0.2295)
+(-0.0060 0.0555 0.2295)
+(-0.0030 0.0555 0.2295)
+(0.0000 0.0555 0.2295)
+(0.0030 0.0555 0.2295)
+(0.0060 0.0555 0.2295)
+(-0.0060 0.0585 0.2295)
+(-0.0030 0.0585 0.2295)
+(0.0000 0.0585 0.2295)
+(0.0030 0.0585 0.2295)
+(0.0060 0.0585 0.2295)
+(-0.0060 0.0615 0.2295)
+(-0.0030 0.0615 0.2295)
+(0.0000 0.0615 0.2295)
+(0.0030 0.0615 0.2295)
+(0.0060 0.0615 0.2295)
+(-0.0060 0.0645 0.2295)
+(-0.0030 0.0645 0.2295)
+(0.0000 0.0645 0.2295)
+(0.0030 0.0645 0.2295)
+(0.0060 0.0645 0.2295)
+(-0.0060 0.0675 0.2295)
+(-0.0030 0.0675 0.2295)
+(0.0000 0.0675 0.2295)
+(0.0030 0.0675 0.2295)
+(0.0060 0.0675 0.2295)
+(-0.0060 0.0705 0.2295)
+(-0.0030 0.0705 0.2295)
+(0.0000 0.0705 0.2295)
+(0.0030 0.0705 0.2295)
+(0.0060 0.0705 0.2295)
+(-0.0060 0.0735 0.2295)
+(-0.0030 0.0735 0.2295)
+(0.0000 0.0735 0.2295)
+(0.0030 0.0735 0.2295)
+(0.0060 0.0735 0.2295)
+(-0.0060 -0.0735 0.2325)
+(-0.0030 -0.0735 0.2325)
+(0.0000 -0.0735 0.2325)
+(0.0030 -0.0735 0.2325)
+(0.0060 -0.0735 0.2325)
+(-0.0060 -0.0705 0.2325)
+(-0.0030 -0.0705 0.2325)
+(0.0000 -0.0705 0.2325)
+(0.0030 -0.0705 0.2325)
+(0.0060 -0.0705 0.2325)
+(-0.0060 -0.0675 0.2325)
+(-0.0030 -0.0675 0.2325)
+(0.0000 -0.0675 0.2325)
+(0.0030 -0.0675 0.2325)
+(0.0060 -0.0675 0.2325)
+(-0.0060 -0.0645 0.2325)
+(-0.0030 -0.0645 0.2325)
+(0.0000 -0.0645 0.2325)
+(0.0030 -0.0645 0.2325)
+(0.0060 -0.0645 0.2325)
+(-0.0060 -0.0615 0.2325)
+(-0.0030 -0.0615 0.2325)
+(0.0000 -0.0615 0.2325)
+(0.0030 -0.0615 0.2325)
+(0.0060 -0.0615 0.2325)
+(-0.0060 -0.0585 0.2325)
+(-0.0030 -0.0585 0.2325)
+(0.0000 -0.0585 0.2325)
+(0.0030 -0.0585 0.2325)
+(0.0060 -0.0585 0.2325)
+(-0.0060 -0.0555 0.2325)
+(-0.0030 -0.0555 0.2325)
+(0.0000 -0.0555 0.2325)
+(0.0030 -0.0555 0.2325)
+(0.0060 -0.0555 0.2325)
+(-0.0060 -0.0525 0.2325)
+(-0.0030 -0.0525 0.2325)
+(0.0000 -0.0525 0.2325)
+(0.0030 -0.0525 0.2325)
+(0.0060 -0.0525 0.2325)
+(-0.0060 -0.0495 0.2325)
+(-0.0030 -0.0495 0.2325)
+(0.0000 -0.0495 0.2325)
+(0.0030 -0.0495 0.2325)
+(0.0060 -0.0495 0.2325)
+(-0.0060 -0.0465 0.2325)
+(-0.0030 -0.0465 0.2325)
+(0.0000 -0.0465 0.2325)
+(0.0030 -0.0465 0.2325)
+(0.0060 -0.0465 0.2325)
+(-0.0060 -0.0435 0.2325)
+(-0.0030 -0.0435 0.2325)
+(0.0000 -0.0435 0.2325)
+(0.0030 -0.0435 0.2325)
+(0.0060 -0.0435 0.2325)
+(-0.0060 -0.0405 0.2325)
+(-0.0030 -0.0405 0.2325)
+(0.0000 -0.0405 0.2325)
+(0.0030 -0.0405 0.2325)
+(0.0060 -0.0405 0.2325)
+(-0.0060 -0.0375 0.2325)
+(-0.0030 -0.0375 0.2325)
+(0.0000 -0.0375 0.2325)
+(0.0030 -0.0375 0.2325)
+(0.0060 -0.0375 0.2325)
+(-0.0060 -0.0345 0.2325)
+(-0.0030 -0.0345 0.2325)
+(0.0000 -0.0345 0.2325)
+(0.0030 -0.0345 0.2325)
+(0.0060 -0.0345 0.2325)
+(-0.0060 -0.0315 0.2325)
+(-0.0030 -0.0315 0.2325)
+(0.0000 -0.0315 0.2325)
+(0.0030 -0.0315 0.2325)
+(0.0060 -0.0315 0.2325)
+(-0.0060 -0.0285 0.2325)
+(-0.0030 -0.0285 0.2325)
+(0.0000 -0.0285 0.2325)
+(0.0030 -0.0285 0.2325)
+(0.0060 -0.0285 0.2325)
+(-0.0060 -0.0255 0.2325)
+(-0.0030 -0.0255 0.2325)
+(0.0000 -0.0255 0.2325)
+(0.0030 -0.0255 0.2325)
+(0.0060 -0.0255 0.2325)
+(-0.0060 -0.0225 0.2325)
+(-0.0030 -0.0225 0.2325)
+(0.0000 -0.0225 0.2325)
+(0.0030 -0.0225 0.2325)
+(0.0060 -0.0225 0.2325)
+(-0.0060 -0.0195 0.2325)
+(-0.0030 -0.0195 0.2325)
+(0.0000 -0.0195 0.2325)
+(0.0030 -0.0195 0.2325)
+(0.0060 -0.0195 0.2325)
+(-0.0060 -0.0165 0.2325)
+(-0.0030 -0.0165 0.2325)
+(0.0000 -0.0165 0.2325)
+(0.0030 -0.0165 0.2325)
+(0.0060 -0.0165 0.2325)
+(-0.0060 -0.0135 0.2325)
+(-0.0030 -0.0135 0.2325)
+(0.0000 -0.0135 0.2325)
+(0.0030 -0.0135 0.2325)
+(0.0060 -0.0135 0.2325)
+(-0.0060 -0.0105 0.2325)
+(-0.0030 -0.0105 0.2325)
+(0.0000 -0.0105 0.2325)
+(0.0030 -0.0105 0.2325)
+(0.0060 -0.0105 0.2325)
+(-0.0060 -0.0075 0.2325)
+(-0.0030 -0.0075 0.2325)
+(0.0000 -0.0075 0.2325)
+(0.0030 -0.0075 0.2325)
+(0.0060 -0.0075 0.2325)
+(-0.0060 -0.0045 0.2325)
+(-0.0030 -0.0045 0.2325)
+(0.0000 -0.0045 0.2325)
+(0.0030 -0.0045 0.2325)
+(0.0060 -0.0045 0.2325)
+(-0.0060 -0.0015 0.2325)
+(-0.0030 -0.0015 0.2325)
+(0.0000 -0.0015 0.2325)
+(0.0030 -0.0015 0.2325)
+(0.0060 -0.0015 0.2325)
+(-0.0060 0.0015 0.2325)
+(-0.0030 0.0015 0.2325)
+(0.0000 0.0015 0.2325)
+(0.0030 0.0015 0.2325)
+(0.0060 0.0015 0.2325)
+(-0.0060 0.0045 0.2325)
+(-0.0030 0.0045 0.2325)
+(0.0000 0.0045 0.2325)
+(0.0030 0.0045 0.2325)
+(0.0060 0.0045 0.2325)
+(-0.0060 0.0075 0.2325)
+(-0.0030 0.0075 0.2325)
+(0.0000 0.0075 0.2325)
+(0.0030 0.0075 0.2325)
+(0.0060 0.0075 0.2325)
+(-0.0060 0.0105 0.2325)
+(-0.0030 0.0105 0.2325)
+(0.0000 0.0105 0.2325)
+(0.0030 0.0105 0.2325)
+(0.0060 0.0105 0.2325)
+(-0.0060 0.0135 0.2325)
+(-0.0030 0.0135 0.2325)
+(0.0000 0.0135 0.2325)
+(0.0030 0.0135 0.2325)
+(0.0060 0.0135 0.2325)
+(-0.0060 0.0165 0.2325)
+(-0.0030 0.0165 0.2325)
+(0.0000 0.0165 0.2325)
+(0.0030 0.0165 0.2325)
+(0.0060 0.0165 0.2325)
+(-0.0060 0.0195 0.2325)
+(-0.0030 0.0195 0.2325)
+(0.0000 0.0195 0.2325)
+(0.0030 0.0195 0.2325)
+(0.0060 0.0195 0.2325)
+(-0.0060 0.0225 0.2325)
+(-0.0030 0.0225 0.2325)
+(0.0000 0.0225 0.2325)
+(0.0030 0.0225 0.2325)
+(0.0060 0.0225 0.2325)
+(-0.0060 0.0255 0.2325)
+(-0.0030 0.0255 0.2325)
+(0.0000 0.0255 0.2325)
+(0.0030 0.0255 0.2325)
+(0.0060 0.0255 0.2325)
+(-0.0060 0.0285 0.2325)
+(-0.0030 0.0285 0.2325)
+(0.0000 0.0285 0.2325)
+(0.0030 0.0285 0.2325)
+(0.0060 0.0285 0.2325)
+(-0.0060 0.0315 0.2325)
+(-0.0030 0.0315 0.2325)
+(0.0000 0.0315 0.2325)
+(0.0030 0.0315 0.2325)
+(0.0060 0.0315 0.2325)
+(-0.0060 0.0345 0.2325)
+(-0.0030 0.0345 0.2325)
+(0.0000 0.0345 0.2325)
+(0.0030 0.0345 0.2325)
+(0.0060 0.0345 0.2325)
+(-0.0060 0.0375 0.2325)
+(-0.0030 0.0375 0.2325)
+(0.0000 0.0375 0.2325)
+(0.0030 0.0375 0.2325)
+(0.0060 0.0375 0.2325)
+(-0.0060 0.0405 0.2325)
+(-0.0030 0.0405 0.2325)
+(0.0000 0.0405 0.2325)
+(0.0030 0.0405 0.2325)
+(0.0060 0.0405 0.2325)
+(-0.0060 0.0435 0.2325)
+(-0.0030 0.0435 0.2325)
+(0.0000 0.0435 0.2325)
+(0.0030 0.0435 0.2325)
+(0.0060 0.0435 0.2325)
+(-0.0060 0.0465 0.2325)
+(-0.0030 0.0465 0.2325)
+(0.0000 0.0465 0.2325)
+(0.0030 0.0465 0.2325)
+(0.0060 0.0465 0.2325)
+(-0.0060 0.0495 0.2325)
+(-0.0030 0.0495 0.2325)
+(0.0000 0.0495 0.2325)
+(0.0030 0.0495 0.2325)
+(0.0060 0.0495 0.2325)
+(-0.0060 0.0525 0.2325)
+(-0.0030 0.0525 0.2325)
+(0.0000 0.0525 0.2325)
+(0.0030 0.0525 0.2325)
+(0.0060 0.0525 0.2325)
+(-0.0060 0.0555 0.2325)
+(-0.0030 0.0555 0.2325)
+(0.0000 0.0555 0.2325)
+(0.0030 0.0555 0.2325)
+(0.0060 0.0555 0.2325)
+(-0.0060 0.0585 0.2325)
+(-0.0030 0.0585 0.2325)
+(0.0000 0.0585 0.2325)
+(0.0030 0.0585 0.2325)
+(0.0060 0.0585 0.2325)
+(-0.0060 0.0615 0.2325)
+(-0.0030 0.0615 0.2325)
+(0.0000 0.0615 0.2325)
+(0.0030 0.0615 0.2325)
+(0.0060 0.0615 0.2325)
+(-0.0060 0.0645 0.2325)
+(-0.0030 0.0645 0.2325)
+(0.0000 0.0645 0.2325)
+(0.0030 0.0645 0.2325)
+(0.0060 0.0645 0.2325)
+(-0.0060 0.0675 0.2325)
+(-0.0030 0.0675 0.2325)
+(0.0000 0.0675 0.2325)
+(0.0030 0.0675 0.2325)
+(0.0060 0.0675 0.2325)
+(-0.0060 0.0705 0.2325)
+(-0.0030 0.0705 0.2325)
+(0.0000 0.0705 0.2325)
+(0.0030 0.0705 0.2325)
+(0.0060 0.0705 0.2325)
+(-0.0060 0.0735 0.2325)
+(-0.0030 0.0735 0.2325)
+(0.0000 0.0735 0.2325)
+(0.0030 0.0735 0.2325)
+(0.0060 0.0735 0.2325)
+(-0.0060 -0.0735 0.2355)
+(-0.0030 -0.0735 0.2355)
+(0.0000 -0.0735 0.2355)
+(0.0030 -0.0735 0.2355)
+(0.0060 -0.0735 0.2355)
+(-0.0060 -0.0705 0.2355)
+(-0.0030 -0.0705 0.2355)
+(0.0000 -0.0705 0.2355)
+(0.0030 -0.0705 0.2355)
+(0.0060 -0.0705 0.2355)
+(-0.0060 -0.0675 0.2355)
+(-0.0030 -0.0675 0.2355)
+(0.0000 -0.0675 0.2355)
+(0.0030 -0.0675 0.2355)
+(0.0060 -0.0675 0.2355)
+(-0.0060 -0.0645 0.2355)
+(-0.0030 -0.0645 0.2355)
+(0.0000 -0.0645 0.2355)
+(0.0030 -0.0645 0.2355)
+(0.0060 -0.0645 0.2355)
+(-0.0060 -0.0615 0.2355)
+(-0.0030 -0.0615 0.2355)
+(0.0000 -0.0615 0.2355)
+(0.0030 -0.0615 0.2355)
+(0.0060 -0.0615 0.2355)
+(-0.0060 -0.0585 0.2355)
+(-0.0030 -0.0585 0.2355)
+(0.0000 -0.0585 0.2355)
+(0.0030 -0.0585 0.2355)
+(0.0060 -0.0585 0.2355)
+(-0.0060 -0.0555 0.2355)
+(-0.0030 -0.0555 0.2355)
+(0.0000 -0.0555 0.2355)
+(0.0030 -0.0555 0.2355)
+(0.0060 -0.0555 0.2355)
+(-0.0060 -0.0525 0.2355)
+(-0.0030 -0.0525 0.2355)
+(0.0000 -0.0525 0.2355)
+(0.0030 -0.0525 0.2355)
+(0.0060 -0.0525 0.2355)
+(-0.0060 -0.0495 0.2355)
+(-0.0030 -0.0495 0.2355)
+(0.0000 -0.0495 0.2355)
+(0.0030 -0.0495 0.2355)
+(0.0060 -0.0495 0.2355)
+(-0.0060 -0.0465 0.2355)
+(-0.0030 -0.0465 0.2355)
+(0.0000 -0.0465 0.2355)
+(0.0030 -0.0465 0.2355)
+(0.0060 -0.0465 0.2355)
+(-0.0060 -0.0435 0.2355)
+(-0.0030 -0.0435 0.2355)
+(0.0000 -0.0435 0.2355)
+(0.0030 -0.0435 0.2355)
+(0.0060 -0.0435 0.2355)
+(-0.0060 -0.0405 0.2355)
+(-0.0030 -0.0405 0.2355)
+(0.0000 -0.0405 0.2355)
+(0.0030 -0.0405 0.2355)
+(0.0060 -0.0405 0.2355)
+(-0.0060 -0.0375 0.2355)
+(-0.0030 -0.0375 0.2355)
+(0.0000 -0.0375 0.2355)
+(0.0030 -0.0375 0.2355)
+(0.0060 -0.0375 0.2355)
+(-0.0060 -0.0345 0.2355)
+(-0.0030 -0.0345 0.2355)
+(0.0000 -0.0345 0.2355)
+(0.0030 -0.0345 0.2355)
+(0.0060 -0.0345 0.2355)
+(-0.0060 -0.0315 0.2355)
+(-0.0030 -0.0315 0.2355)
+(0.0000 -0.0315 0.2355)
+(0.0030 -0.0315 0.2355)
+(0.0060 -0.0315 0.2355)
+(-0.0060 -0.0285 0.2355)
+(-0.0030 -0.0285 0.2355)
+(0.0000 -0.0285 0.2355)
+(0.0030 -0.0285 0.2355)
+(0.0060 -0.0285 0.2355)
+(-0.0060 -0.0255 0.2355)
+(-0.0030 -0.0255 0.2355)
+(0.0000 -0.0255 0.2355)
+(0.0030 -0.0255 0.2355)
+(0.0060 -0.0255 0.2355)
+(-0.0060 -0.0225 0.2355)
+(-0.0030 -0.0225 0.2355)
+(0.0000 -0.0225 0.2355)
+(0.0030 -0.0225 0.2355)
+(0.0060 -0.0225 0.2355)
+(-0.0060 -0.0195 0.2355)
+(-0.0030 -0.0195 0.2355)
+(0.0000 -0.0195 0.2355)
+(0.0030 -0.0195 0.2355)
+(0.0060 -0.0195 0.2355)
+(-0.0060 -0.0165 0.2355)
+(-0.0030 -0.0165 0.2355)
+(0.0000 -0.0165 0.2355)
+(0.0030 -0.0165 0.2355)
+(0.0060 -0.0165 0.2355)
+(-0.0060 -0.0135 0.2355)
+(-0.0030 -0.0135 0.2355)
+(0.0000 -0.0135 0.2355)
+(0.0030 -0.0135 0.2355)
+(0.0060 -0.0135 0.2355)
+(-0.0060 -0.0105 0.2355)
+(-0.0030 -0.0105 0.2355)
+(0.0000 -0.0105 0.2355)
+(0.0030 -0.0105 0.2355)
+(0.0060 -0.0105 0.2355)
+(-0.0060 -0.0075 0.2355)
+(-0.0030 -0.0075 0.2355)
+(0.0000 -0.0075 0.2355)
+(0.0030 -0.0075 0.2355)
+(0.0060 -0.0075 0.2355)
+(-0.0060 -0.0045 0.2355)
+(-0.0030 -0.0045 0.2355)
+(0.0000 -0.0045 0.2355)
+(0.0030 -0.0045 0.2355)
+(0.0060 -0.0045 0.2355)
+(-0.0060 -0.0015 0.2355)
+(-0.0030 -0.0015 0.2355)
+(0.0000 -0.0015 0.2355)
+(0.0030 -0.0015 0.2355)
+(0.0060 -0.0015 0.2355)
+(-0.0060 0.0015 0.2355)
+(-0.0030 0.0015 0.2355)
+(0.0000 0.0015 0.2355)
+(0.0030 0.0015 0.2355)
+(0.0060 0.0015 0.2355)
+(-0.0060 0.0045 0.2355)
+(-0.0030 0.0045 0.2355)
+(0.0000 0.0045 0.2355)
+(0.0030 0.0045 0.2355)
+(0.0060 0.0045 0.2355)
+(-0.0060 0.0075 0.2355)
+(-0.0030 0.0075 0.2355)
+(0.0000 0.0075 0.2355)
+(0.0030 0.0075 0.2355)
+(0.0060 0.0075 0.2355)
+(-0.0060 0.0105 0.2355)
+(-0.0030 0.0105 0.2355)
+(0.0000 0.0105 0.2355)
+(0.0030 0.0105 0.2355)
+(0.0060 0.0105 0.2355)
+(-0.0060 0.0135 0.2355)
+(-0.0030 0.0135 0.2355)
+(0.0000 0.0135 0.2355)
+(0.0030 0.0135 0.2355)
+(0.0060 0.0135 0.2355)
+(-0.0060 0.0165 0.2355)
+(-0.0030 0.0165 0.2355)
+(0.0000 0.0165 0.2355)
+(0.0030 0.0165 0.2355)
+(0.0060 0.0165 0.2355)
+(-0.0060 0.0195 0.2355)
+(-0.0030 0.0195 0.2355)
+(0.0000 0.0195 0.2355)
+(0.0030 0.0195 0.2355)
+(0.0060 0.0195 0.2355)
+(-0.0060 0.0225 0.2355)
+(-0.0030 0.0225 0.2355)
+(0.0000 0.0225 0.2355)
+(0.0030 0.0225 0.2355)
+(0.0060 0.0225 0.2355)
+(-0.0060 0.0255 0.2355)
+(-0.0030 0.0255 0.2355)
+(0.0000 0.0255 0.2355)
+(0.0030 0.0255 0.2355)
+(0.0060 0.0255 0.2355)
+(-0.0060 0.0285 0.2355)
+(-0.0030 0.0285 0.2355)
+(0.0000 0.0285 0.2355)
+(0.0030 0.0285 0.2355)
+(0.0060 0.0285 0.2355)
+(-0.0060 0.0315 0.2355)
+(-0.0030 0.0315 0.2355)
+(0.0000 0.0315 0.2355)
+(0.0030 0.0315 0.2355)
+(0.0060 0.0315 0.2355)
+(-0.0060 0.0345 0.2355)
+(-0.0030 0.0345 0.2355)
+(0.0000 0.0345 0.2355)
+(0.0030 0.0345 0.2355)
+(0.0060 0.0345 0.2355)
+(-0.0060 0.0375 0.2355)
+(-0.0030 0.0375 0.2355)
+(0.0000 0.0375 0.2355)
+(0.0030 0.0375 0.2355)
+(0.0060 0.0375 0.2355)
+(-0.0060 0.0405 0.2355)
+(-0.0030 0.0405 0.2355)
+(0.0000 0.0405 0.2355)
+(0.0030 0.0405 0.2355)
+(0.0060 0.0405 0.2355)
+(-0.0060 0.0435 0.2355)
+(-0.0030 0.0435 0.2355)
+(0.0000 0.0435 0.2355)
+(0.0030 0.0435 0.2355)
+(0.0060 0.0435 0.2355)
+(-0.0060 0.0465 0.2355)
+(-0.0030 0.0465 0.2355)
+(0.0000 0.0465 0.2355)
+(0.0030 0.0465 0.2355)
+(0.0060 0.0465 0.2355)
+(-0.0060 0.0495 0.2355)
+(-0.0030 0.0495 0.2355)
+(0.0000 0.0495 0.2355)
+(0.0030 0.0495 0.2355)
+(0.0060 0.0495 0.2355)
+(-0.0060 0.0525 0.2355)
+(-0.0030 0.0525 0.2355)
+(0.0000 0.0525 0.2355)
+(0.0030 0.0525 0.2355)
+(0.0060 0.0525 0.2355)
+(-0.0060 0.0555 0.2355)
+(-0.0030 0.0555 0.2355)
+(0.0000 0.0555 0.2355)
+(0.0030 0.0555 0.2355)
+(0.0060 0.0555 0.2355)
+(-0.0060 0.0585 0.2355)
+(-0.0030 0.0585 0.2355)
+(0.0000 0.0585 0.2355)
+(0.0030 0.0585 0.2355)
+(0.0060 0.0585 0.2355)
+(-0.0060 0.0615 0.2355)
+(-0.0030 0.0615 0.2355)
+(0.0000 0.0615 0.2355)
+(0.0030 0.0615 0.2355)
+(0.0060 0.0615 0.2355)
+(-0.0060 0.0645 0.2355)
+(-0.0030 0.0645 0.2355)
+(0.0000 0.0645 0.2355)
+(0.0030 0.0645 0.2355)
+(0.0060 0.0645 0.2355)
+(-0.0060 0.0675 0.2355)
+(-0.0030 0.0675 0.2355)
+(0.0000 0.0675 0.2355)
+(0.0030 0.0675 0.2355)
+(0.0060 0.0675 0.2355)
+(-0.0060 0.0705 0.2355)
+(-0.0030 0.0705 0.2355)
+(0.0000 0.0705 0.2355)
+(0.0030 0.0705 0.2355)
+(0.0060 0.0705 0.2355)
+(-0.0060 0.0735 0.2355)
+(-0.0030 0.0735 0.2355)
+(0.0000 0.0735 0.2355)
+(0.0030 0.0735 0.2355)
+(0.0060 0.0735 0.2355)
+(-0.0060 -0.0735 0.2385)
+(-0.0030 -0.0735 0.2385)
+(0.0000 -0.0735 0.2385)
+(0.0030 -0.0735 0.2385)
+(0.0060 -0.0735 0.2385)
+(-0.0060 -0.0705 0.2385)
+(-0.0030 -0.0705 0.2385)
+(0.0000 -0.0705 0.2385)
+(0.0030 -0.0705 0.2385)
+(0.0060 -0.0705 0.2385)
+(-0.0060 -0.0675 0.2385)
+(-0.0030 -0.0675 0.2385)
+(0.0000 -0.0675 0.2385)
+(0.0030 -0.0675 0.2385)
+(0.0060 -0.0675 0.2385)
+(-0.0060 -0.0645 0.2385)
+(-0.0030 -0.0645 0.2385)
+(0.0000 -0.0645 0.2385)
+(0.0030 -0.0645 0.2385)
+(0.0060 -0.0645 0.2385)
+(-0.0060 -0.0615 0.2385)
+(-0.0030 -0.0615 0.2385)
+(0.0000 -0.0615 0.2385)
+(0.0030 -0.0615 0.2385)
+(0.0060 -0.0615 0.2385)
+(-0.0060 -0.0585 0.2385)
+(-0.0030 -0.0585 0.2385)
+(0.0000 -0.0585 0.2385)
+(0.0030 -0.0585 0.2385)
+(0.0060 -0.0585 0.2385)
+(-0.0060 -0.0555 0.2385)
+(-0.0030 -0.0555 0.2385)
+(0.0000 -0.0555 0.2385)
+(0.0030 -0.0555 0.2385)
+(0.0060 -0.0555 0.2385)
+(-0.0060 -0.0525 0.2385)
+(-0.0030 -0.0525 0.2385)
+(0.0000 -0.0525 0.2385)
+(0.0030 -0.0525 0.2385)
+(0.0060 -0.0525 0.2385)
+(-0.0060 -0.0495 0.2385)
+(-0.0030 -0.0495 0.2385)
+(0.0000 -0.0495 0.2385)
+(0.0030 -0.0495 0.2385)
+(0.0060 -0.0495 0.2385)
+(-0.0060 -0.0465 0.2385)
+(-0.0030 -0.0465 0.2385)
+(0.0000 -0.0465 0.2385)
+(0.0030 -0.0465 0.2385)
+(0.0060 -0.0465 0.2385)
+(-0.0060 -0.0435 0.2385)
+(-0.0030 -0.0435 0.2385)
+(0.0000 -0.0435 0.2385)
+(0.0030 -0.0435 0.2385)
+(0.0060 -0.0435 0.2385)
+(-0.0060 -0.0405 0.2385)
+(-0.0030 -0.0405 0.2385)
+(0.0000 -0.0405 0.2385)
+(0.0030 -0.0405 0.2385)
+(0.0060 -0.0405 0.2385)
+(-0.0060 -0.0375 0.2385)
+(-0.0030 -0.0375 0.2385)
+(0.0000 -0.0375 0.2385)
+(0.0030 -0.0375 0.2385)
+(0.0060 -0.0375 0.2385)
+(-0.0060 -0.0345 0.2385)
+(-0.0030 -0.0345 0.2385)
+(0.0000 -0.0345 0.2385)
+(0.0030 -0.0345 0.2385)
+(0.0060 -0.0345 0.2385)
+(-0.0060 -0.0315 0.2385)
+(-0.0030 -0.0315 0.2385)
+(0.0000 -0.0315 0.2385)
+(0.0030 -0.0315 0.2385)
+(0.0060 -0.0315 0.2385)
+(-0.0060 -0.0285 0.2385)
+(-0.0030 -0.0285 0.2385)
+(0.0000 -0.0285 0.2385)
+(0.0030 -0.0285 0.2385)
+(0.0060 -0.0285 0.2385)
+(-0.0060 -0.0255 0.2385)
+(-0.0030 -0.0255 0.2385)
+(0.0000 -0.0255 0.2385)
+(0.0030 -0.0255 0.2385)
+(0.0060 -0.0255 0.2385)
+(-0.0060 -0.0225 0.2385)
+(-0.0030 -0.0225 0.2385)
+(0.0000 -0.0225 0.2385)
+(0.0030 -0.0225 0.2385)
+(0.0060 -0.0225 0.2385)
+(-0.0060 -0.0195 0.2385)
+(-0.0030 -0.0195 0.2385)
+(0.0000 -0.0195 0.2385)
+(0.0030 -0.0195 0.2385)
+(0.0060 -0.0195 0.2385)
+(-0.0060 -0.0165 0.2385)
+(-0.0030 -0.0165 0.2385)
+(0.0000 -0.0165 0.2385)
+(0.0030 -0.0165 0.2385)
+(0.0060 -0.0165 0.2385)
+(-0.0060 -0.0135 0.2385)
+(-0.0030 -0.0135 0.2385)
+(0.0000 -0.0135 0.2385)
+(0.0030 -0.0135 0.2385)
+(0.0060 -0.0135 0.2385)
+(-0.0060 -0.0105 0.2385)
+(-0.0030 -0.0105 0.2385)
+(0.0000 -0.0105 0.2385)
+(0.0030 -0.0105 0.2385)
+(0.0060 -0.0105 0.2385)
+(-0.0060 -0.0075 0.2385)
+(-0.0030 -0.0075 0.2385)
+(0.0000 -0.0075 0.2385)
+(0.0030 -0.0075 0.2385)
+(0.0060 -0.0075 0.2385)
+(-0.0060 -0.0045 0.2385)
+(-0.0030 -0.0045 0.2385)
+(0.0000 -0.0045 0.2385)
+(0.0030 -0.0045 0.2385)
+(0.0060 -0.0045 0.2385)
+(-0.0060 -0.0015 0.2385)
+(-0.0030 -0.0015 0.2385)
+(0.0000 -0.0015 0.2385)
+(0.0030 -0.0015 0.2385)
+(0.0060 -0.0015 0.2385)
+(-0.0060 0.0015 0.2385)
+(-0.0030 0.0015 0.2385)
+(0.0000 0.0015 0.2385)
+(0.0030 0.0015 0.2385)
+(0.0060 0.0015 0.2385)
+(-0.0060 0.0045 0.2385)
+(-0.0030 0.0045 0.2385)
+(0.0000 0.0045 0.2385)
+(0.0030 0.0045 0.2385)
+(0.0060 0.0045 0.2385)
+(-0.0060 0.0075 0.2385)
+(-0.0030 0.0075 0.2385)
+(0.0000 0.0075 0.2385)
+(0.0030 0.0075 0.2385)
+(0.0060 0.0075 0.2385)
+(-0.0060 0.0105 0.2385)
+(-0.0030 0.0105 0.2385)
+(0.0000 0.0105 0.2385)
+(0.0030 0.0105 0.2385)
+(0.0060 0.0105 0.2385)
+(-0.0060 0.0135 0.2385)
+(-0.0030 0.0135 0.2385)
+(0.0000 0.0135 0.2385)
+(0.0030 0.0135 0.2385)
+(0.0060 0.0135 0.2385)
+(-0.0060 0.0165 0.2385)
+(-0.0030 0.0165 0.2385)
+(0.0000 0.0165 0.2385)
+(0.0030 0.0165 0.2385)
+(0.0060 0.0165 0.2385)
+(-0.0060 0.0195 0.2385)
+(-0.0030 0.0195 0.2385)
+(0.0000 0.0195 0.2385)
+(0.0030 0.0195 0.2385)
+(0.0060 0.0195 0.2385)
+(-0.0060 0.0225 0.2385)
+(-0.0030 0.0225 0.2385)
+(0.0000 0.0225 0.2385)
+(0.0030 0.0225 0.2385)
+(0.0060 0.0225 0.2385)
+(-0.0060 0.0255 0.2385)
+(-0.0030 0.0255 0.2385)
+(0.0000 0.0255 0.2385)
+(0.0030 0.0255 0.2385)
+(0.0060 0.0255 0.2385)
+(-0.0060 0.0285 0.2385)
+(-0.0030 0.0285 0.2385)
+(0.0000 0.0285 0.2385)
+(0.0030 0.0285 0.2385)
+(0.0060 0.0285 0.2385)
+(-0.0060 0.0315 0.2385)
+(-0.0030 0.0315 0.2385)
+(0.0000 0.0315 0.2385)
+(0.0030 0.0315 0.2385)
+(0.0060 0.0315 0.2385)
+(-0.0060 0.0345 0.2385)
+(-0.0030 0.0345 0.2385)
+(0.0000 0.0345 0.2385)
+(0.0030 0.0345 0.2385)
+(0.0060 0.0345 0.2385)
+(-0.0060 0.0375 0.2385)
+(-0.0030 0.0375 0.2385)
+(0.0000 0.0375 0.2385)
+(0.0030 0.0375 0.2385)
+(0.0060 0.0375 0.2385)
+(-0.0060 0.0405 0.2385)
+(-0.0030 0.0405 0.2385)
+(0.0000 0.0405 0.2385)
+(0.0030 0.0405 0.2385)
+(0.0060 0.0405 0.2385)
+(-0.0060 0.0435 0.2385)
+(-0.0030 0.0435 0.2385)
+(0.0000 0.0435 0.2385)
+(0.0030 0.0435 0.2385)
+(0.0060 0.0435 0.2385)
+(-0.0060 0.0465 0.2385)
+(-0.0030 0.0465 0.2385)
+(0.0000 0.0465 0.2385)
+(0.0030 0.0465 0.2385)
+(0.0060 0.0465 0.2385)
+(-0.0060 0.0495 0.2385)
+(-0.0030 0.0495 0.2385)
+(0.0000 0.0495 0.2385)
+(0.0030 0.0495 0.2385)
+(0.0060 0.0495 0.2385)
+(-0.0060 0.0525 0.2385)
+(-0.0030 0.0525 0.2385)
+(0.0000 0.0525 0.2385)
+(0.0030 0.0525 0.2385)
+(0.0060 0.0525 0.2385)
+(-0.0060 0.0555 0.2385)
+(-0.0030 0.0555 0.2385)
+(0.0000 0.0555 0.2385)
+(0.0030 0.0555 0.2385)
+(0.0060 0.0555 0.2385)
+(-0.0060 0.0585 0.2385)
+(-0.0030 0.0585 0.2385)
+(0.0000 0.0585 0.2385)
+(0.0030 0.0585 0.2385)
+(0.0060 0.0585 0.2385)
+(-0.0060 0.0615 0.2385)
+(-0.0030 0.0615 0.2385)
+(0.0000 0.0615 0.2385)
+(0.0030 0.0615 0.2385)
+(0.0060 0.0615 0.2385)
+(-0.0060 0.0645 0.2385)
+(-0.0030 0.0645 0.2385)
+(0.0000 0.0645 0.2385)
+(0.0030 0.0645 0.2385)
+(0.0060 0.0645 0.2385)
+(-0.0060 0.0675 0.2385)
+(-0.0030 0.0675 0.2385)
+(0.0000 0.0675 0.2385)
+(0.0030 0.0675 0.2385)
+(0.0060 0.0675 0.2385)
+(-0.0060 0.0705 0.2385)
+(-0.0030 0.0705 0.2385)
+(0.0000 0.0705 0.2385)
+(0.0030 0.0705 0.2385)
+(0.0060 0.0705 0.2385)
+(-0.0060 0.0735 0.2385)
+(-0.0030 0.0735 0.2385)
+(0.0000 0.0735 0.2385)
+(0.0030 0.0735 0.2385)
+(0.0060 0.0735 0.2385)
+(-0.0060 -0.0735 0.2415)
+(-0.0030 -0.0735 0.2415)
+(0.0000 -0.0735 0.2415)
+(0.0030 -0.0735 0.2415)
+(0.0060 -0.0735 0.2415)
+(-0.0060 -0.0705 0.2415)
+(-0.0030 -0.0705 0.2415)
+(0.0000 -0.0705 0.2415)
+(0.0030 -0.0705 0.2415)
+(0.0060 -0.0705 0.2415)
+(-0.0060 -0.0675 0.2415)
+(-0.0030 -0.0675 0.2415)
+(0.0000 -0.0675 0.2415)
+(0.0030 -0.0675 0.2415)
+(0.0060 -0.0675 0.2415)
+(-0.0060 -0.0645 0.2415)
+(-0.0030 -0.0645 0.2415)
+(0.0000 -0.0645 0.2415)
+(0.0030 -0.0645 0.2415)
+(0.0060 -0.0645 0.2415)
+(-0.0060 -0.0615 0.2415)
+(-0.0030 -0.0615 0.2415)
+(0.0000 -0.0615 0.2415)
+(0.0030 -0.0615 0.2415)
+(0.0060 -0.0615 0.2415)
+(-0.0060 -0.0585 0.2415)
+(-0.0030 -0.0585 0.2415)
+(0.0000 -0.0585 0.2415)
+(0.0030 -0.0585 0.2415)
+(0.0060 -0.0585 0.2415)
+(-0.0060 -0.0555 0.2415)
+(-0.0030 -0.0555 0.2415)
+(0.0000 -0.0555 0.2415)
+(0.0030 -0.0555 0.2415)
+(0.0060 -0.0555 0.2415)
+(-0.0060 -0.0525 0.2415)
+(-0.0030 -0.0525 0.2415)
+(0.0000 -0.0525 0.2415)
+(0.0030 -0.0525 0.2415)
+(0.0060 -0.0525 0.2415)
+(-0.0060 -0.0495 0.2415)
+(-0.0030 -0.0495 0.2415)
+(0.0000 -0.0495 0.2415)
+(0.0030 -0.0495 0.2415)
+(0.0060 -0.0495 0.2415)
+(-0.0060 -0.0465 0.2415)
+(-0.0030 -0.0465 0.2415)
+(0.0000 -0.0465 0.2415)
+(0.0030 -0.0465 0.2415)
+(0.0060 -0.0465 0.2415)
+(-0.0060 -0.0435 0.2415)
+(-0.0030 -0.0435 0.2415)
+(0.0000 -0.0435 0.2415)
+(0.0030 -0.0435 0.2415)
+(0.0060 -0.0435 0.2415)
+(-0.0060 -0.0405 0.2415)
+(-0.0030 -0.0405 0.2415)
+(0.0000 -0.0405 0.2415)
+(0.0030 -0.0405 0.2415)
+(0.0060 -0.0405 0.2415)
+(-0.0060 -0.0375 0.2415)
+(-0.0030 -0.0375 0.2415)
+(0.0000 -0.0375 0.2415)
+(0.0030 -0.0375 0.2415)
+(0.0060 -0.0375 0.2415)
+(-0.0060 -0.0345 0.2415)
+(-0.0030 -0.0345 0.2415)
+(0.0000 -0.0345 0.2415)
+(0.0030 -0.0345 0.2415)
+(0.0060 -0.0345 0.2415)
+(-0.0060 -0.0315 0.2415)
+(-0.0030 -0.0315 0.2415)
+(0.0000 -0.0315 0.2415)
+(0.0030 -0.0315 0.2415)
+(0.0060 -0.0315 0.2415)
+(-0.0060 -0.0285 0.2415)
+(-0.0030 -0.0285 0.2415)
+(0.0000 -0.0285 0.2415)
+(0.0030 -0.0285 0.2415)
+(0.0060 -0.0285 0.2415)
+(-0.0060 -0.0255 0.2415)
+(-0.0030 -0.0255 0.2415)
+(0.0000 -0.0255 0.2415)
+(0.0030 -0.0255 0.2415)
+(0.0060 -0.0255 0.2415)
+(-0.0060 -0.0225 0.2415)
+(-0.0030 -0.0225 0.2415)
+(0.0000 -0.0225 0.2415)
+(0.0030 -0.0225 0.2415)
+(0.0060 -0.0225 0.2415)
+(-0.0060 -0.0195 0.2415)
+(-0.0030 -0.0195 0.2415)
+(0.0000 -0.0195 0.2415)
+(0.0030 -0.0195 0.2415)
+(0.0060 -0.0195 0.2415)
+(-0.0060 -0.0165 0.2415)
+(-0.0030 -0.0165 0.2415)
+(0.0000 -0.0165 0.2415)
+(0.0030 -0.0165 0.2415)
+(0.0060 -0.0165 0.2415)
+(-0.0060 -0.0135 0.2415)
+(-0.0030 -0.0135 0.2415)
+(0.0000 -0.0135 0.2415)
+(0.0030 -0.0135 0.2415)
+(0.0060 -0.0135 0.2415)
+(-0.0060 -0.0105 0.2415)
+(-0.0030 -0.0105 0.2415)
+(0.0000 -0.0105 0.2415)
+(0.0030 -0.0105 0.2415)
+(0.0060 -0.0105 0.2415)
+(-0.0060 -0.0075 0.2415)
+(-0.0030 -0.0075 0.2415)
+(0.0000 -0.0075 0.2415)
+(0.0030 -0.0075 0.2415)
+(0.0060 -0.0075 0.2415)
+(-0.0060 -0.0045 0.2415)
+(-0.0030 -0.0045 0.2415)
+(0.0000 -0.0045 0.2415)
+(0.0030 -0.0045 0.2415)
+(0.0060 -0.0045 0.2415)
+(-0.0060 -0.0015 0.2415)
+(-0.0030 -0.0015 0.2415)
+(0.0000 -0.0015 0.2415)
+(0.0030 -0.0015 0.2415)
+(0.0060 -0.0015 0.2415)
+(-0.0060 0.0015 0.2415)
+(-0.0030 0.0015 0.2415)
+(0.0000 0.0015 0.2415)
+(0.0030 0.0015 0.2415)
+(0.0060 0.0015 0.2415)
+(-0.0060 0.0045 0.2415)
+(-0.0030 0.0045 0.2415)
+(0.0000 0.0045 0.2415)
+(0.0030 0.0045 0.2415)
+(0.0060 0.0045 0.2415)
+(-0.0060 0.0075 0.2415)
+(-0.0030 0.0075 0.2415)
+(0.0000 0.0075 0.2415)
+(0.0030 0.0075 0.2415)
+(0.0060 0.0075 0.2415)
+(-0.0060 0.0105 0.2415)
+(-0.0030 0.0105 0.2415)
+(0.0000 0.0105 0.2415)
+(0.0030 0.0105 0.2415)
+(0.0060 0.0105 0.2415)
+(-0.0060 0.0135 0.2415)
+(-0.0030 0.0135 0.2415)
+(0.0000 0.0135 0.2415)
+(0.0030 0.0135 0.2415)
+(0.0060 0.0135 0.2415)
+(-0.0060 0.0165 0.2415)
+(-0.0030 0.0165 0.2415)
+(0.0000 0.0165 0.2415)
+(0.0030 0.0165 0.2415)
+(0.0060 0.0165 0.2415)
+(-0.0060 0.0195 0.2415)
+(-0.0030 0.0195 0.2415)
+(0.0000 0.0195 0.2415)
+(0.0030 0.0195 0.2415)
+(0.0060 0.0195 0.2415)
+(-0.0060 0.0225 0.2415)
+(-0.0030 0.0225 0.2415)
+(0.0000 0.0225 0.2415)
+(0.0030 0.0225 0.2415)
+(0.0060 0.0225 0.2415)
+(-0.0060 0.0255 0.2415)
+(-0.0030 0.0255 0.2415)
+(0.0000 0.0255 0.2415)
+(0.0030 0.0255 0.2415)
+(0.0060 0.0255 0.2415)
+(-0.0060 0.0285 0.2415)
+(-0.0030 0.0285 0.2415)
+(0.0000 0.0285 0.2415)
+(0.0030 0.0285 0.2415)
+(0.0060 0.0285 0.2415)
+(-0.0060 0.0315 0.2415)
+(-0.0030 0.0315 0.2415)
+(0.0000 0.0315 0.2415)
+(0.0030 0.0315 0.2415)
+(0.0060 0.0315 0.2415)
+(-0.0060 0.0345 0.2415)
+(-0.0030 0.0345 0.2415)
+(0.0000 0.0345 0.2415)
+(0.0030 0.0345 0.2415)
+(0.0060 0.0345 0.2415)
+(-0.0060 0.0375 0.2415)
+(-0.0030 0.0375 0.2415)
+(0.0000 0.0375 0.2415)
+(0.0030 0.0375 0.2415)
+(0.0060 0.0375 0.2415)
+(-0.0060 0.0405 0.2415)
+(-0.0030 0.0405 0.2415)
+(0.0000 0.0405 0.2415)
+(0.0030 0.0405 0.2415)
+(0.0060 0.0405 0.2415)
+(-0.0060 0.0435 0.2415)
+(-0.0030 0.0435 0.2415)
+(0.0000 0.0435 0.2415)
+(0.0030 0.0435 0.2415)
+(0.0060 0.0435 0.2415)
+(-0.0060 0.0465 0.2415)
+(-0.0030 0.0465 0.2415)
+(0.0000 0.0465 0.2415)
+(0.0030 0.0465 0.2415)
+(0.0060 0.0465 0.2415)
+(-0.0060 0.0495 0.2415)
+(-0.0030 0.0495 0.2415)
+(0.0000 0.0495 0.2415)
+(0.0030 0.0495 0.2415)
+(0.0060 0.0495 0.2415)
+(-0.0060 0.0525 0.2415)
+(-0.0030 0.0525 0.2415)
+(0.0000 0.0525 0.2415)
+(0.0030 0.0525 0.2415)
+(0.0060 0.0525 0.2415)
+(-0.0060 0.0555 0.2415)
+(-0.0030 0.0555 0.2415)
+(0.0000 0.0555 0.2415)
+(0.0030 0.0555 0.2415)
+(0.0060 0.0555 0.2415)
+(-0.0060 0.0585 0.2415)
+(-0.0030 0.0585 0.2415)
+(0.0000 0.0585 0.2415)
+(0.0030 0.0585 0.2415)
+(0.0060 0.0585 0.2415)
+(-0.0060 0.0615 0.2415)
+(-0.0030 0.0615 0.2415)
+(0.0000 0.0615 0.2415)
+(0.0030 0.0615 0.2415)
+(0.0060 0.0615 0.2415)
+(-0.0060 0.0645 0.2415)
+(-0.0030 0.0645 0.2415)
+(0.0000 0.0645 0.2415)
+(0.0030 0.0645 0.2415)
+(0.0060 0.0645 0.2415)
+(-0.0060 0.0675 0.2415)
+(-0.0030 0.0675 0.2415)
+(0.0000 0.0675 0.2415)
+(0.0030 0.0675 0.2415)
+(0.0060 0.0675 0.2415)
+(-0.0060 0.0705 0.2415)
+(-0.0030 0.0705 0.2415)
+(0.0000 0.0705 0.2415)
+(0.0030 0.0705 0.2415)
+(0.0060 0.0705 0.2415)
+(-0.0060 0.0735 0.2415)
+(-0.0030 0.0735 0.2415)
+(0.0000 0.0735 0.2415)
+(0.0030 0.0735 0.2415)
+(0.0060 0.0735 0.2415)
+(-0.0060 -0.0735 0.2445)
+(-0.0030 -0.0735 0.2445)
+(0.0000 -0.0735 0.2445)
+(0.0030 -0.0735 0.2445)
+(0.0060 -0.0735 0.2445)
+(-0.0060 -0.0705 0.2445)
+(-0.0030 -0.0705 0.2445)
+(0.0000 -0.0705 0.2445)
+(0.0030 -0.0705 0.2445)
+(0.0060 -0.0705 0.2445)
+(-0.0060 -0.0675 0.2445)
+(-0.0030 -0.0675 0.2445)
+(0.0000 -0.0675 0.2445)
+(0.0030 -0.0675 0.2445)
+(0.0060 -0.0675 0.2445)
+(-0.0060 -0.0645 0.2445)
+(-0.0030 -0.0645 0.2445)
+(0.0000 -0.0645 0.2445)
+(0.0030 -0.0645 0.2445)
+(0.0060 -0.0645 0.2445)
+(-0.0060 -0.0615 0.2445)
+(-0.0030 -0.0615 0.2445)
+(0.0000 -0.0615 0.2445)
+(0.0030 -0.0615 0.2445)
+(0.0060 -0.0615 0.2445)
+(-0.0060 -0.0585 0.2445)
+(-0.0030 -0.0585 0.2445)
+(0.0000 -0.0585 0.2445)
+(0.0030 -0.0585 0.2445)
+(0.0060 -0.0585 0.2445)
+(-0.0060 -0.0555 0.2445)
+(-0.0030 -0.0555 0.2445)
+(0.0000 -0.0555 0.2445)
+(0.0030 -0.0555 0.2445)
+(0.0060 -0.0555 0.2445)
+(-0.0060 -0.0525 0.2445)
+(-0.0030 -0.0525 0.2445)
+(0.0000 -0.0525 0.2445)
+(0.0030 -0.0525 0.2445)
+(0.0060 -0.0525 0.2445)
+(-0.0060 -0.0495 0.2445)
+(-0.0030 -0.0495 0.2445)
+(0.0000 -0.0495 0.2445)
+(0.0030 -0.0495 0.2445)
+(0.0060 -0.0495 0.2445)
+(-0.0060 -0.0465 0.2445)
+(-0.0030 -0.0465 0.2445)
+(0.0000 -0.0465 0.2445)
+(0.0030 -0.0465 0.2445)
+(0.0060 -0.0465 0.2445)
+(-0.0060 -0.0435 0.2445)
+(-0.0030 -0.0435 0.2445)
+(0.0000 -0.0435 0.2445)
+(0.0030 -0.0435 0.2445)
+(0.0060 -0.0435 0.2445)
+(-0.0060 -0.0405 0.2445)
+(-0.0030 -0.0405 0.2445)
+(0.0000 -0.0405 0.2445)
+(0.0030 -0.0405 0.2445)
+(0.0060 -0.0405 0.2445)
+(-0.0060 -0.0375 0.2445)
+(-0.0030 -0.0375 0.2445)
+(0.0000 -0.0375 0.2445)
+(0.0030 -0.0375 0.2445)
+(0.0060 -0.0375 0.2445)
+(-0.0060 -0.0345 0.2445)
+(-0.0030 -0.0345 0.2445)
+(0.0000 -0.0345 0.2445)
+(0.0030 -0.0345 0.2445)
+(0.0060 -0.0345 0.2445)
+(-0.0060 -0.0315 0.2445)
+(-0.0030 -0.0315 0.2445)
+(0.0000 -0.0315 0.2445)
+(0.0030 -0.0315 0.2445)
+(0.0060 -0.0315 0.2445)
+(-0.0060 -0.0285 0.2445)
+(-0.0030 -0.0285 0.2445)
+(0.0000 -0.0285 0.2445)
+(0.0030 -0.0285 0.2445)
+(0.0060 -0.0285 0.2445)
+(-0.0060 -0.0255 0.2445)
+(-0.0030 -0.0255 0.2445)
+(0.0000 -0.0255 0.2445)
+(0.0030 -0.0255 0.2445)
+(0.0060 -0.0255 0.2445)
+(-0.0060 -0.0225 0.2445)
+(-0.0030 -0.0225 0.2445)
+(0.0000 -0.0225 0.2445)
+(0.0030 -0.0225 0.2445)
+(0.0060 -0.0225 0.2445)
+(-0.0060 -0.0195 0.2445)
+(-0.0030 -0.0195 0.2445)
+(0.0000 -0.0195 0.2445)
+(0.0030 -0.0195 0.2445)
+(0.0060 -0.0195 0.2445)
+(-0.0060 -0.0165 0.2445)
+(-0.0030 -0.0165 0.2445)
+(0.0000 -0.0165 0.2445)
+(0.0030 -0.0165 0.2445)
+(0.0060 -0.0165 0.2445)
+(-0.0060 -0.0135 0.2445)
+(-0.0030 -0.0135 0.2445)
+(0.0000 -0.0135 0.2445)
+(0.0030 -0.0135 0.2445)
+(0.0060 -0.0135 0.2445)
+(-0.0060 -0.0105 0.2445)
+(-0.0030 -0.0105 0.2445)
+(0.0000 -0.0105 0.2445)
+(0.0030 -0.0105 0.2445)
+(0.0060 -0.0105 0.2445)
+(-0.0060 -0.0075 0.2445)
+(-0.0030 -0.0075 0.2445)
+(0.0000 -0.0075 0.2445)
+(0.0030 -0.0075 0.2445)
+(0.0060 -0.0075 0.2445)
+(-0.0060 -0.0045 0.2445)
+(-0.0030 -0.0045 0.2445)
+(0.0000 -0.0045 0.2445)
+(0.0030 -0.0045 0.2445)
+(0.0060 -0.0045 0.2445)
+(-0.0060 -0.0015 0.2445)
+(-0.0030 -0.0015 0.2445)
+(0.0000 -0.0015 0.2445)
+(0.0030 -0.0015 0.2445)
+(0.0060 -0.0015 0.2445)
+(-0.0060 0.0015 0.2445)
+(-0.0030 0.0015 0.2445)
+(0.0000 0.0015 0.2445)
+(0.0030 0.0015 0.2445)
+(0.0060 0.0015 0.2445)
+(-0.0060 0.0045 0.2445)
+(-0.0030 0.0045 0.2445)
+(0.0000 0.0045 0.2445)
+(0.0030 0.0045 0.2445)
+(0.0060 0.0045 0.2445)
+(-0.0060 0.0075 0.2445)
+(-0.0030 0.0075 0.2445)
+(0.0000 0.0075 0.2445)
+(0.0030 0.0075 0.2445)
+(0.0060 0.0075 0.2445)
+(-0.0060 0.0105 0.2445)
+(-0.0030 0.0105 0.2445)
+(0.0000 0.0105 0.2445)
+(0.0030 0.0105 0.2445)
+(0.0060 0.0105 0.2445)
+(-0.0060 0.0135 0.2445)
+(-0.0030 0.0135 0.2445)
+(0.0000 0.0135 0.2445)
+(0.0030 0.0135 0.2445)
+(0.0060 0.0135 0.2445)
+(-0.0060 0.0165 0.2445)
+(-0.0030 0.0165 0.2445)
+(0.0000 0.0165 0.2445)
+(0.0030 0.0165 0.2445)
+(0.0060 0.0165 0.2445)
+(-0.0060 0.0195 0.2445)
+(-0.0030 0.0195 0.2445)
+(0.0000 0.0195 0.2445)
+(0.0030 0.0195 0.2445)
+(0.0060 0.0195 0.2445)
+(-0.0060 0.0225 0.2445)
+(-0.0030 0.0225 0.2445)
+(0.0000 0.0225 0.2445)
+(0.0030 0.0225 0.2445)
+(0.0060 0.0225 0.2445)
+(-0.0060 0.0255 0.2445)
+(-0.0030 0.0255 0.2445)
+(0.0000 0.0255 0.2445)
+(0.0030 0.0255 0.2445)
+(0.0060 0.0255 0.2445)
+(-0.0060 0.0285 0.2445)
+(-0.0030 0.0285 0.2445)
+(0.0000 0.0285 0.2445)
+(0.0030 0.0285 0.2445)
+(0.0060 0.0285 0.2445)
+(-0.0060 0.0315 0.2445)
+(-0.0030 0.0315 0.2445)
+(0.0000 0.0315 0.2445)
+(0.0030 0.0315 0.2445)
+(0.0060 0.0315 0.2445)
+(-0.0060 0.0345 0.2445)
+(-0.0030 0.0345 0.2445)
+(0.0000 0.0345 0.2445)
+(0.0030 0.0345 0.2445)
+(0.0060 0.0345 0.2445)
+(-0.0060 0.0375 0.2445)
+(-0.0030 0.0375 0.2445)
+(0.0000 0.0375 0.2445)
+(0.0030 0.0375 0.2445)
+(0.0060 0.0375 0.2445)
+(-0.0060 0.0405 0.2445)
+(-0.0030 0.0405 0.2445)
+(0.0000 0.0405 0.2445)
+(0.0030 0.0405 0.2445)
+(0.0060 0.0405 0.2445)
+(-0.0060 0.0435 0.2445)
+(-0.0030 0.0435 0.2445)
+(0.0000 0.0435 0.2445)
+(0.0030 0.0435 0.2445)
+(0.0060 0.0435 0.2445)
+(-0.0060 0.0465 0.2445)
+(-0.0030 0.0465 0.2445)
+(0.0000 0.0465 0.2445)
+(0.0030 0.0465 0.2445)
+(0.0060 0.0465 0.2445)
+(-0.0060 0.0495 0.2445)
+(-0.0030 0.0495 0.2445)
+(0.0000 0.0495 0.2445)
+(0.0030 0.0495 0.2445)
+(0.0060 0.0495 0.2445)
+(-0.0060 0.0525 0.2445)
+(-0.0030 0.0525 0.2445)
+(0.0000 0.0525 0.2445)
+(0.0030 0.0525 0.2445)
+(0.0060 0.0525 0.2445)
+(-0.0060 0.0555 0.2445)
+(-0.0030 0.0555 0.2445)
+(0.0000 0.0555 0.2445)
+(0.0030 0.0555 0.2445)
+(0.0060 0.0555 0.2445)
+(-0.0060 0.0585 0.2445)
+(-0.0030 0.0585 0.2445)
+(0.0000 0.0585 0.2445)
+(0.0030 0.0585 0.2445)
+(0.0060 0.0585 0.2445)
+(-0.0060 0.0615 0.2445)
+(-0.0030 0.0615 0.2445)
+(0.0000 0.0615 0.2445)
+(0.0030 0.0615 0.2445)
+(0.0060 0.0615 0.2445)
+(-0.0060 0.0645 0.2445)
+(-0.0030 0.0645 0.2445)
+(0.0000 0.0645 0.2445)
+(0.0030 0.0645 0.2445)
+(0.0060 0.0645 0.2445)
+(-0.0060 0.0675 0.2445)
+(-0.0030 0.0675 0.2445)
+(0.0000 0.0675 0.2445)
+(0.0030 0.0675 0.2445)
+(0.0060 0.0675 0.2445)
+(-0.0060 0.0705 0.2445)
+(-0.0030 0.0705 0.2445)
+(0.0000 0.0705 0.2445)
+(0.0030 0.0705 0.2445)
+(0.0060 0.0705 0.2445)
+(-0.0060 0.0735 0.2445)
+(-0.0030 0.0735 0.2445)
+(0.0000 0.0735 0.2445)
+(0.0030 0.0735 0.2445)
+(0.0060 0.0735 0.2445)
+(-0.0060 -0.0735 0.2475)
+(-0.0030 -0.0735 0.2475)
+(0.0000 -0.0735 0.2475)
+(0.0030 -0.0735 0.2475)
+(0.0060 -0.0735 0.2475)
+(-0.0060 -0.0705 0.2475)
+(-0.0030 -0.0705 0.2475)
+(0.0000 -0.0705 0.2475)
+(0.0030 -0.0705 0.2475)
+(0.0060 -0.0705 0.2475)
+(-0.0060 -0.0675 0.2475)
+(-0.0030 -0.0675 0.2475)
+(0.0000 -0.0675 0.2475)
+(0.0030 -0.0675 0.2475)
+(0.0060 -0.0675 0.2475)
+(-0.0060 -0.0645 0.2475)
+(-0.0030 -0.0645 0.2475)
+(0.0000 -0.0645 0.2475)
+(0.0030 -0.0645 0.2475)
+(0.0060 -0.0645 0.2475)
+(-0.0060 -0.0615 0.2475)
+(-0.0030 -0.0615 0.2475)
+(0.0000 -0.0615 0.2475)
+(0.0030 -0.0615 0.2475)
+(0.0060 -0.0615 0.2475)
+(-0.0060 -0.0585 0.2475)
+(-0.0030 -0.0585 0.2475)
+(0.0000 -0.0585 0.2475)
+(0.0030 -0.0585 0.2475)
+(0.0060 -0.0585 0.2475)
+(-0.0060 -0.0555 0.2475)
+(-0.0030 -0.0555 0.2475)
+(0.0000 -0.0555 0.2475)
+(0.0030 -0.0555 0.2475)
+(0.0060 -0.0555 0.2475)
+(-0.0060 -0.0525 0.2475)
+(-0.0030 -0.0525 0.2475)
+(0.0000 -0.0525 0.2475)
+(0.0030 -0.0525 0.2475)
+(0.0060 -0.0525 0.2475)
+(-0.0060 -0.0495 0.2475)
+(-0.0030 -0.0495 0.2475)
+(0.0000 -0.0495 0.2475)
+(0.0030 -0.0495 0.2475)
+(0.0060 -0.0495 0.2475)
+(-0.0060 -0.0465 0.2475)
+(-0.0030 -0.0465 0.2475)
+(0.0000 -0.0465 0.2475)
+(0.0030 -0.0465 0.2475)
+(0.0060 -0.0465 0.2475)
+(-0.0060 -0.0435 0.2475)
+(-0.0030 -0.0435 0.2475)
+(0.0000 -0.0435 0.2475)
+(0.0030 -0.0435 0.2475)
+(0.0060 -0.0435 0.2475)
+(-0.0060 -0.0405 0.2475)
+(-0.0030 -0.0405 0.2475)
+(0.0000 -0.0405 0.2475)
+(0.0030 -0.0405 0.2475)
+(0.0060 -0.0405 0.2475)
+(-0.0060 -0.0375 0.2475)
+(-0.0030 -0.0375 0.2475)
+(0.0000 -0.0375 0.2475)
+(0.0030 -0.0375 0.2475)
+(0.0060 -0.0375 0.2475)
+(-0.0060 -0.0345 0.2475)
+(-0.0030 -0.0345 0.2475)
+(0.0000 -0.0345 0.2475)
+(0.0030 -0.0345 0.2475)
+(0.0060 -0.0345 0.2475)
+(-0.0060 -0.0315 0.2475)
+(-0.0030 -0.0315 0.2475)
+(0.0000 -0.0315 0.2475)
+(0.0030 -0.0315 0.2475)
+(0.0060 -0.0315 0.2475)
+(-0.0060 -0.0285 0.2475)
+(-0.0030 -0.0285 0.2475)
+(0.0000 -0.0285 0.2475)
+(0.0030 -0.0285 0.2475)
+(0.0060 -0.0285 0.2475)
+(-0.0060 -0.0255 0.2475)
+(-0.0030 -0.0255 0.2475)
+(0.0000 -0.0255 0.2475)
+(0.0030 -0.0255 0.2475)
+(0.0060 -0.0255 0.2475)
+(-0.0060 -0.0225 0.2475)
+(-0.0030 -0.0225 0.2475)
+(0.0000 -0.0225 0.2475)
+(0.0030 -0.0225 0.2475)
+(0.0060 -0.0225 0.2475)
+(-0.0060 -0.0195 0.2475)
+(-0.0030 -0.0195 0.2475)
+(0.0000 -0.0195 0.2475)
+(0.0030 -0.0195 0.2475)
+(0.0060 -0.0195 0.2475)
+(-0.0060 -0.0165 0.2475)
+(-0.0030 -0.0165 0.2475)
+(0.0000 -0.0165 0.2475)
+(0.0030 -0.0165 0.2475)
+(0.0060 -0.0165 0.2475)
+(-0.0060 -0.0135 0.2475)
+(-0.0030 -0.0135 0.2475)
+(0.0000 -0.0135 0.2475)
+(0.0030 -0.0135 0.2475)
+(0.0060 -0.0135 0.2475)
+(-0.0060 -0.0105 0.2475)
+(-0.0030 -0.0105 0.2475)
+(0.0000 -0.0105 0.2475)
+(0.0030 -0.0105 0.2475)
+(0.0060 -0.0105 0.2475)
+(-0.0060 -0.0075 0.2475)
+(-0.0030 -0.0075 0.2475)
+(0.0000 -0.0075 0.2475)
+(0.0030 -0.0075 0.2475)
+(0.0060 -0.0075 0.2475)
+(-0.0060 -0.0045 0.2475)
+(-0.0030 -0.0045 0.2475)
+(0.0000 -0.0045 0.2475)
+(0.0030 -0.0045 0.2475)
+(0.0060 -0.0045 0.2475)
+(-0.0060 -0.0015 0.2475)
+(-0.0030 -0.0015 0.2475)
+(0.0000 -0.0015 0.2475)
+(0.0030 -0.0015 0.2475)
+(0.0060 -0.0015 0.2475)
+(-0.0060 0.0015 0.2475)
+(-0.0030 0.0015 0.2475)
+(0.0000 0.0015 0.2475)
+(0.0030 0.0015 0.2475)
+(0.0060 0.0015 0.2475)
+(-0.0060 0.0045 0.2475)
+(-0.0030 0.0045 0.2475)
+(0.0000 0.0045 0.2475)
+(0.0030 0.0045 0.2475)
+(0.0060 0.0045 0.2475)
+(-0.0060 0.0075 0.2475)
+(-0.0030 0.0075 0.2475)
+(0.0000 0.0075 0.2475)
+(0.0030 0.0075 0.2475)
+(0.0060 0.0075 0.2475)
+(-0.0060 0.0105 0.2475)
+(-0.0030 0.0105 0.2475)
+(0.0000 0.0105 0.2475)
+(0.0030 0.0105 0.2475)
+(0.0060 0.0105 0.2475)
+(-0.0060 0.0135 0.2475)
+(-0.0030 0.0135 0.2475)
+(0.0000 0.0135 0.2475)
+(0.0030 0.0135 0.2475)
+(0.0060 0.0135 0.2475)
+(-0.0060 0.0165 0.2475)
+(-0.0030 0.0165 0.2475)
+(0.0000 0.0165 0.2475)
+(0.0030 0.0165 0.2475)
+(0.0060 0.0165 0.2475)
+(-0.0060 0.0195 0.2475)
+(-0.0030 0.0195 0.2475)
+(0.0000 0.0195 0.2475)
+(0.0030 0.0195 0.2475)
+(0.0060 0.0195 0.2475)
+(-0.0060 0.0225 0.2475)
+(-0.0030 0.0225 0.2475)
+(0.0000 0.0225 0.2475)
+(0.0030 0.0225 0.2475)
+(0.0060 0.0225 0.2475)
+(-0.0060 0.0255 0.2475)
+(-0.0030 0.0255 0.2475)
+(0.0000 0.0255 0.2475)
+(0.0030 0.0255 0.2475)
+(0.0060 0.0255 0.2475)
+(-0.0060 0.0285 0.2475)
+(-0.0030 0.0285 0.2475)
+(0.0000 0.0285 0.2475)
+(0.0030 0.0285 0.2475)
+(0.0060 0.0285 0.2475)
+(-0.0060 0.0315 0.2475)
+(-0.0030 0.0315 0.2475)
+(0.0000 0.0315 0.2475)
+(0.0030 0.0315 0.2475)
+(0.0060 0.0315 0.2475)
+(-0.0060 0.0345 0.2475)
+(-0.0030 0.0345 0.2475)
+(0.0000 0.0345 0.2475)
+(0.0030 0.0345 0.2475)
+(0.0060 0.0345 0.2475)
+(-0.0060 0.0375 0.2475)
+(-0.0030 0.0375 0.2475)
+(0.0000 0.0375 0.2475)
+(0.0030 0.0375 0.2475)
+(0.0060 0.0375 0.2475)
+(-0.0060 0.0405 0.2475)
+(-0.0030 0.0405 0.2475)
+(0.0000 0.0405 0.2475)
+(0.0030 0.0405 0.2475)
+(0.0060 0.0405 0.2475)
+(-0.0060 0.0435 0.2475)
+(-0.0030 0.0435 0.2475)
+(0.0000 0.0435 0.2475)
+(0.0030 0.0435 0.2475)
+(0.0060 0.0435 0.2475)
+(-0.0060 0.0465 0.2475)
+(-0.0030 0.0465 0.2475)
+(0.0000 0.0465 0.2475)
+(0.0030 0.0465 0.2475)
+(0.0060 0.0465 0.2475)
+(-0.0060 0.0495 0.2475)
+(-0.0030 0.0495 0.2475)
+(0.0000 0.0495 0.2475)
+(0.0030 0.0495 0.2475)
+(0.0060 0.0495 0.2475)
+(-0.0060 0.0525 0.2475)
+(-0.0030 0.0525 0.2475)
+(0.0000 0.0525 0.2475)
+(0.0030 0.0525 0.2475)
+(0.0060 0.0525 0.2475)
+(-0.0060 0.0555 0.2475)
+(-0.0030 0.0555 0.2475)
+(0.0000 0.0555 0.2475)
+(0.0030 0.0555 0.2475)
+(0.0060 0.0555 0.2475)
+(-0.0060 0.0585 0.2475)
+(-0.0030 0.0585 0.2475)
+(0.0000 0.0585 0.2475)
+(0.0030 0.0585 0.2475)
+(0.0060 0.0585 0.2475)
+(-0.0060 0.0615 0.2475)
+(-0.0030 0.0615 0.2475)
+(0.0000 0.0615 0.2475)
+(0.0030 0.0615 0.2475)
+(0.0060 0.0615 0.2475)
+(-0.0060 0.0645 0.2475)
+(-0.0030 0.0645 0.2475)
+(0.0000 0.0645 0.2475)
+(0.0030 0.0645 0.2475)
+(0.0060 0.0645 0.2475)
+(-0.0060 0.0675 0.2475)
+(-0.0030 0.0675 0.2475)
+(0.0000 0.0675 0.2475)
+(0.0030 0.0675 0.2475)
+(0.0060 0.0675 0.2475)
+(-0.0060 0.0705 0.2475)
+(-0.0030 0.0705 0.2475)
+(0.0000 0.0705 0.2475)
+(0.0030 0.0705 0.2475)
+(0.0060 0.0705 0.2475)
+(-0.0060 0.0735 0.2475)
+(-0.0030 0.0735 0.2475)
+(0.0000 0.0735 0.2475)
+(0.0030 0.0735 0.2475)
+(0.0060 0.0735 0.2475)
+(-0.0060 -0.0735 0.2505)
+(-0.0030 -0.0735 0.2505)
+(0.0000 -0.0735 0.2505)
+(0.0030 -0.0735 0.2505)
+(0.0060 -0.0735 0.2505)
+(-0.0060 -0.0705 0.2505)
+(-0.0030 -0.0705 0.2505)
+(0.0000 -0.0705 0.2505)
+(0.0030 -0.0705 0.2505)
+(0.0060 -0.0705 0.2505)
+(-0.0060 -0.0675 0.2505)
+(-0.0030 -0.0675 0.2505)
+(0.0000 -0.0675 0.2505)
+(0.0030 -0.0675 0.2505)
+(0.0060 -0.0675 0.2505)
+(-0.0060 -0.0645 0.2505)
+(-0.0030 -0.0645 0.2505)
+(0.0000 -0.0645 0.2505)
+(0.0030 -0.0645 0.2505)
+(0.0060 -0.0645 0.2505)
+(-0.0060 -0.0615 0.2505)
+(-0.0030 -0.0615 0.2505)
+(0.0000 -0.0615 0.2505)
+(0.0030 -0.0615 0.2505)
+(0.0060 -0.0615 0.2505)
+(-0.0060 -0.0585 0.2505)
+(-0.0030 -0.0585 0.2505)
+(0.0000 -0.0585 0.2505)
+(0.0030 -0.0585 0.2505)
+(0.0060 -0.0585 0.2505)
+(-0.0060 -0.0555 0.2505)
+(-0.0030 -0.0555 0.2505)
+(0.0000 -0.0555 0.2505)
+(0.0030 -0.0555 0.2505)
+(0.0060 -0.0555 0.2505)
+(-0.0060 -0.0525 0.2505)
+(-0.0030 -0.0525 0.2505)
+(0.0000 -0.0525 0.2505)
+(0.0030 -0.0525 0.2505)
+(0.0060 -0.0525 0.2505)
+(-0.0060 -0.0495 0.2505)
+(-0.0030 -0.0495 0.2505)
+(0.0000 -0.0495 0.2505)
+(0.0030 -0.0495 0.2505)
+(0.0060 -0.0495 0.2505)
+(-0.0060 -0.0465 0.2505)
+(-0.0030 -0.0465 0.2505)
+(0.0000 -0.0465 0.2505)
+(0.0030 -0.0465 0.2505)
+(0.0060 -0.0465 0.2505)
+(-0.0060 -0.0435 0.2505)
+(-0.0030 -0.0435 0.2505)
+(0.0000 -0.0435 0.2505)
+(0.0030 -0.0435 0.2505)
+(0.0060 -0.0435 0.2505)
+(-0.0060 -0.0405 0.2505)
+(-0.0030 -0.0405 0.2505)
+(0.0000 -0.0405 0.2505)
+(0.0030 -0.0405 0.2505)
+(0.0060 -0.0405 0.2505)
+(-0.0060 -0.0375 0.2505)
+(-0.0030 -0.0375 0.2505)
+(0.0000 -0.0375 0.2505)
+(0.0030 -0.0375 0.2505)
+(0.0060 -0.0375 0.2505)
+(-0.0060 -0.0345 0.2505)
+(-0.0030 -0.0345 0.2505)
+(0.0000 -0.0345 0.2505)
+(0.0030 -0.0345 0.2505)
+(0.0060 -0.0345 0.2505)
+(-0.0060 -0.0315 0.2505)
+(-0.0030 -0.0315 0.2505)
+(0.0000 -0.0315 0.2505)
+(0.0030 -0.0315 0.2505)
+(0.0060 -0.0315 0.2505)
+(-0.0060 -0.0285 0.2505)
+(-0.0030 -0.0285 0.2505)
+(0.0000 -0.0285 0.2505)
+(0.0030 -0.0285 0.2505)
+(0.0060 -0.0285 0.2505)
+(-0.0060 -0.0255 0.2505)
+(-0.0030 -0.0255 0.2505)
+(0.0000 -0.0255 0.2505)
+(0.0030 -0.0255 0.2505)
+(0.0060 -0.0255 0.2505)
+(-0.0060 -0.0225 0.2505)
+(-0.0030 -0.0225 0.2505)
+(0.0000 -0.0225 0.2505)
+(0.0030 -0.0225 0.2505)
+(0.0060 -0.0225 0.2505)
+(-0.0060 -0.0195 0.2505)
+(-0.0030 -0.0195 0.2505)
+(0.0000 -0.0195 0.2505)
+(0.0030 -0.0195 0.2505)
+(0.0060 -0.0195 0.2505)
+(-0.0060 -0.0165 0.2505)
+(-0.0030 -0.0165 0.2505)
+(0.0000 -0.0165 0.2505)
+(0.0030 -0.0165 0.2505)
+(0.0060 -0.0165 0.2505)
+(-0.0060 -0.0135 0.2505)
+(-0.0030 -0.0135 0.2505)
+(0.0000 -0.0135 0.2505)
+(0.0030 -0.0135 0.2505)
+(0.0060 -0.0135 0.2505)
+(-0.0060 -0.0105 0.2505)
+(-0.0030 -0.0105 0.2505)
+(0.0000 -0.0105 0.2505)
+(0.0030 -0.0105 0.2505)
+(0.0060 -0.0105 0.2505)
+(-0.0060 -0.0075 0.2505)
+(-0.0030 -0.0075 0.2505)
+(0.0000 -0.0075 0.2505)
+(0.0030 -0.0075 0.2505)
+(0.0060 -0.0075 0.2505)
+(-0.0060 -0.0045 0.2505)
+(-0.0030 -0.0045 0.2505)
+(0.0000 -0.0045 0.2505)
+(0.0030 -0.0045 0.2505)
+(0.0060 -0.0045 0.2505)
+(-0.0060 -0.0015 0.2505)
+(-0.0030 -0.0015 0.2505)
+(0.0000 -0.0015 0.2505)
+(0.0030 -0.0015 0.2505)
+(0.0060 -0.0015 0.2505)
+(-0.0060 0.0015 0.2505)
+(-0.0030 0.0015 0.2505)
+(0.0000 0.0015 0.2505)
+(0.0030 0.0015 0.2505)
+(0.0060 0.0015 0.2505)
+(-0.0060 0.0045 0.2505)
+(-0.0030 0.0045 0.2505)
+(0.0000 0.0045 0.2505)
+(0.0030 0.0045 0.2505)
+(0.0060 0.0045 0.2505)
+(-0.0060 0.0075 0.2505)
+(-0.0030 0.0075 0.2505)
+(0.0000 0.0075 0.2505)
+(0.0030 0.0075 0.2505)
+(0.0060 0.0075 0.2505)
+(-0.0060 0.0105 0.2505)
+(-0.0030 0.0105 0.2505)
+(0.0000 0.0105 0.2505)
+(0.0030 0.0105 0.2505)
+(0.0060 0.0105 0.2505)
+(-0.0060 0.0135 0.2505)
+(-0.0030 0.0135 0.2505)
+(0.0000 0.0135 0.2505)
+(0.0030 0.0135 0.2505)
+(0.0060 0.0135 0.2505)
+(-0.0060 0.0165 0.2505)
+(-0.0030 0.0165 0.2505)
+(0.0000 0.0165 0.2505)
+(0.0030 0.0165 0.2505)
+(0.0060 0.0165 0.2505)
+(-0.0060 0.0195 0.2505)
+(-0.0030 0.0195 0.2505)
+(0.0000 0.0195 0.2505)
+(0.0030 0.0195 0.2505)
+(0.0060 0.0195 0.2505)
+(-0.0060 0.0225 0.2505)
+(-0.0030 0.0225 0.2505)
+(0.0000 0.0225 0.2505)
+(0.0030 0.0225 0.2505)
+(0.0060 0.0225 0.2505)
+(-0.0060 0.0255 0.2505)
+(-0.0030 0.0255 0.2505)
+(0.0000 0.0255 0.2505)
+(0.0030 0.0255 0.2505)
+(0.0060 0.0255 0.2505)
+(-0.0060 0.0285 0.2505)
+(-0.0030 0.0285 0.2505)
+(0.0000 0.0285 0.2505)
+(0.0030 0.0285 0.2505)
+(0.0060 0.0285 0.2505)
+(-0.0060 0.0315 0.2505)
+(-0.0030 0.0315 0.2505)
+(0.0000 0.0315 0.2505)
+(0.0030 0.0315 0.2505)
+(0.0060 0.0315 0.2505)
+(-0.0060 0.0345 0.2505)
+(-0.0030 0.0345 0.2505)
+(0.0000 0.0345 0.2505)
+(0.0030 0.0345 0.2505)
+(0.0060 0.0345 0.2505)
+(-0.0060 0.0375 0.2505)
+(-0.0030 0.0375 0.2505)
+(0.0000 0.0375 0.2505)
+(0.0030 0.0375 0.2505)
+(0.0060 0.0375 0.2505)
+(-0.0060 0.0405 0.2505)
+(-0.0030 0.0405 0.2505)
+(0.0000 0.0405 0.2505)
+(0.0030 0.0405 0.2505)
+(0.0060 0.0405 0.2505)
+(-0.0060 0.0435 0.2505)
+(-0.0030 0.0435 0.2505)
+(0.0000 0.0435 0.2505)
+(0.0030 0.0435 0.2505)
+(0.0060 0.0435 0.2505)
+(-0.0060 0.0465 0.2505)
+(-0.0030 0.0465 0.2505)
+(0.0000 0.0465 0.2505)
+(0.0030 0.0465 0.2505)
+(0.0060 0.0465 0.2505)
+(-0.0060 0.0495 0.2505)
+(-0.0030 0.0495 0.2505)
+(0.0000 0.0495 0.2505)
+(0.0030 0.0495 0.2505)
+(0.0060 0.0495 0.2505)
+(-0.0060 0.0525 0.2505)
+(-0.0030 0.0525 0.2505)
+(0.0000 0.0525 0.2505)
+(0.0030 0.0525 0.2505)
+(0.0060 0.0525 0.2505)
+(-0.0060 0.0555 0.2505)
+(-0.0030 0.0555 0.2505)
+(0.0000 0.0555 0.2505)
+(0.0030 0.0555 0.2505)
+(0.0060 0.0555 0.2505)
+(-0.0060 0.0585 0.2505)
+(-0.0030 0.0585 0.2505)
+(0.0000 0.0585 0.2505)
+(0.0030 0.0585 0.2505)
+(0.0060 0.0585 0.2505)
+(-0.0060 0.0615 0.2505)
+(-0.0030 0.0615 0.2505)
+(0.0000 0.0615 0.2505)
+(0.0030 0.0615 0.2505)
+(0.0060 0.0615 0.2505)
+(-0.0060 0.0645 0.2505)
+(-0.0030 0.0645 0.2505)
+(0.0000 0.0645 0.2505)
+(0.0030 0.0645 0.2505)
+(0.0060 0.0645 0.2505)
+(-0.0060 0.0675 0.2505)
+(-0.0030 0.0675 0.2505)
+(0.0000 0.0675 0.2505)
+(0.0030 0.0675 0.2505)
+(0.0060 0.0675 0.2505)
+(-0.0060 0.0705 0.2505)
+(-0.0030 0.0705 0.2505)
+(0.0000 0.0705 0.2505)
+(0.0030 0.0705 0.2505)
+(0.0060 0.0705 0.2505)
+(-0.0060 0.0735 0.2505)
+(-0.0030 0.0735 0.2505)
+(0.0000 0.0735 0.2505)
+(0.0030 0.0735 0.2505)
+(0.0060 0.0735 0.2505)
+(-0.0060 -0.0735 0.2535)
+(-0.0030 -0.0735 0.2535)
+(0.0000 -0.0735 0.2535)
+(0.0030 -0.0735 0.2535)
+(0.0060 -0.0735 0.2535)
+(-0.0060 -0.0705 0.2535)
+(-0.0030 -0.0705 0.2535)
+(0.0000 -0.0705 0.2535)
+(0.0030 -0.0705 0.2535)
+(0.0060 -0.0705 0.2535)
+(-0.0060 -0.0675 0.2535)
+(-0.0030 -0.0675 0.2535)
+(0.0000 -0.0675 0.2535)
+(0.0030 -0.0675 0.2535)
+(0.0060 -0.0675 0.2535)
+(-0.0060 -0.0645 0.2535)
+(-0.0030 -0.0645 0.2535)
+(0.0000 -0.0645 0.2535)
+(0.0030 -0.0645 0.2535)
+(0.0060 -0.0645 0.2535)
+(-0.0060 -0.0615 0.2535)
+(-0.0030 -0.0615 0.2535)
+(0.0000 -0.0615 0.2535)
+(0.0030 -0.0615 0.2535)
+(0.0060 -0.0615 0.2535)
+(-0.0060 -0.0585 0.2535)
+(-0.0030 -0.0585 0.2535)
+(0.0000 -0.0585 0.2535)
+(0.0030 -0.0585 0.2535)
+(0.0060 -0.0585 0.2535)
+(-0.0060 -0.0555 0.2535)
+(-0.0030 -0.0555 0.2535)
+(0.0000 -0.0555 0.2535)
+(0.0030 -0.0555 0.2535)
+(0.0060 -0.0555 0.2535)
+(-0.0060 -0.0525 0.2535)
+(-0.0030 -0.0525 0.2535)
+(0.0000 -0.0525 0.2535)
+(0.0030 -0.0525 0.2535)
+(0.0060 -0.0525 0.2535)
+(-0.0060 -0.0495 0.2535)
+(-0.0030 -0.0495 0.2535)
+(0.0000 -0.0495 0.2535)
+(0.0030 -0.0495 0.2535)
+(0.0060 -0.0495 0.2535)
+(-0.0060 -0.0465 0.2535)
+(-0.0030 -0.0465 0.2535)
+(0.0000 -0.0465 0.2535)
+(0.0030 -0.0465 0.2535)
+(0.0060 -0.0465 0.2535)
+(-0.0060 -0.0435 0.2535)
+(-0.0030 -0.0435 0.2535)
+(0.0000 -0.0435 0.2535)
+(0.0030 -0.0435 0.2535)
+(0.0060 -0.0435 0.2535)
+(-0.0060 -0.0405 0.2535)
+(-0.0030 -0.0405 0.2535)
+(0.0000 -0.0405 0.2535)
+(0.0030 -0.0405 0.2535)
+(0.0060 -0.0405 0.2535)
+(-0.0060 -0.0375 0.2535)
+(-0.0030 -0.0375 0.2535)
+(0.0000 -0.0375 0.2535)
+(0.0030 -0.0375 0.2535)
+(0.0060 -0.0375 0.2535)
+(-0.0060 -0.0345 0.2535)
+(-0.0030 -0.0345 0.2535)
+(0.0000 -0.0345 0.2535)
+(0.0030 -0.0345 0.2535)
+(0.0060 -0.0345 0.2535)
+(-0.0060 -0.0315 0.2535)
+(-0.0030 -0.0315 0.2535)
+(0.0000 -0.0315 0.2535)
+(0.0030 -0.0315 0.2535)
+(0.0060 -0.0315 0.2535)
+(-0.0060 -0.0285 0.2535)
+(-0.0030 -0.0285 0.2535)
+(0.0000 -0.0285 0.2535)
+(0.0030 -0.0285 0.2535)
+(0.0060 -0.0285 0.2535)
+(-0.0060 -0.0255 0.2535)
+(-0.0030 -0.0255 0.2535)
+(0.0000 -0.0255 0.2535)
+(0.0030 -0.0255 0.2535)
+(0.0060 -0.0255 0.2535)
+(-0.0060 -0.0225 0.2535)
+(-0.0030 -0.0225 0.2535)
+(0.0000 -0.0225 0.2535)
+(0.0030 -0.0225 0.2535)
+(0.0060 -0.0225 0.2535)
+(-0.0060 -0.0195 0.2535)
+(-0.0030 -0.0195 0.2535)
+(0.0000 -0.0195 0.2535)
+(0.0030 -0.0195 0.2535)
+(0.0060 -0.0195 0.2535)
+(-0.0060 -0.0165 0.2535)
+(-0.0030 -0.0165 0.2535)
+(0.0000 -0.0165 0.2535)
+(0.0030 -0.0165 0.2535)
+(0.0060 -0.0165 0.2535)
+(-0.0060 -0.0135 0.2535)
+(-0.0030 -0.0135 0.2535)
+(0.0000 -0.0135 0.2535)
+(0.0030 -0.0135 0.2535)
+(0.0060 -0.0135 0.2535)
+(-0.0060 -0.0105 0.2535)
+(-0.0030 -0.0105 0.2535)
+(0.0000 -0.0105 0.2535)
+(0.0030 -0.0105 0.2535)
+(0.0060 -0.0105 0.2535)
+(-0.0060 -0.0075 0.2535)
+(-0.0030 -0.0075 0.2535)
+(0.0000 -0.0075 0.2535)
+(0.0030 -0.0075 0.2535)
+(0.0060 -0.0075 0.2535)
+(-0.0060 -0.0045 0.2535)
+(-0.0030 -0.0045 0.2535)
+(0.0000 -0.0045 0.2535)
+(0.0030 -0.0045 0.2535)
+(0.0060 -0.0045 0.2535)
+(-0.0060 -0.0015 0.2535)
+(-0.0030 -0.0015 0.2535)
+(0.0000 -0.0015 0.2535)
+(0.0030 -0.0015 0.2535)
+(0.0060 -0.0015 0.2535)
+(-0.0060 0.0015 0.2535)
+(-0.0030 0.0015 0.2535)
+(0.0000 0.0015 0.2535)
+(0.0030 0.0015 0.2535)
+(0.0060 0.0015 0.2535)
+(-0.0060 0.0045 0.2535)
+(-0.0030 0.0045 0.2535)
+(0.0000 0.0045 0.2535)
+(0.0030 0.0045 0.2535)
+(0.0060 0.0045 0.2535)
+(-0.0060 0.0075 0.2535)
+(-0.0030 0.0075 0.2535)
+(0.0000 0.0075 0.2535)
+(0.0030 0.0075 0.2535)
+(0.0060 0.0075 0.2535)
+(-0.0060 0.0105 0.2535)
+(-0.0030 0.0105 0.2535)
+(0.0000 0.0105 0.2535)
+(0.0030 0.0105 0.2535)
+(0.0060 0.0105 0.2535)
+(-0.0060 0.0135 0.2535)
+(-0.0030 0.0135 0.2535)
+(0.0000 0.0135 0.2535)
+(0.0030 0.0135 0.2535)
+(0.0060 0.0135 0.2535)
+(-0.0060 0.0165 0.2535)
+(-0.0030 0.0165 0.2535)
+(0.0000 0.0165 0.2535)
+(0.0030 0.0165 0.2535)
+(0.0060 0.0165 0.2535)
+(-0.0060 0.0195 0.2535)
+(-0.0030 0.0195 0.2535)
+(0.0000 0.0195 0.2535)
+(0.0030 0.0195 0.2535)
+(0.0060 0.0195 0.2535)
+(-0.0060 0.0225 0.2535)
+(-0.0030 0.0225 0.2535)
+(0.0000 0.0225 0.2535)
+(0.0030 0.0225 0.2535)
+(0.0060 0.0225 0.2535)
+(-0.0060 0.0255 0.2535)
+(-0.0030 0.0255 0.2535)
+(0.0000 0.0255 0.2535)
+(0.0030 0.0255 0.2535)
+(0.0060 0.0255 0.2535)
+(-0.0060 0.0285 0.2535)
+(-0.0030 0.0285 0.2535)
+(0.0000 0.0285 0.2535)
+(0.0030 0.0285 0.2535)
+(0.0060 0.0285 0.2535)
+(-0.0060 0.0315 0.2535)
+(-0.0030 0.0315 0.2535)
+(0.0000 0.0315 0.2535)
+(0.0030 0.0315 0.2535)
+(0.0060 0.0315 0.2535)
+(-0.0060 0.0345 0.2535)
+(-0.0030 0.0345 0.2535)
+(0.0000 0.0345 0.2535)
+(0.0030 0.0345 0.2535)
+(0.0060 0.0345 0.2535)
+(-0.0060 0.0375 0.2535)
+(-0.0030 0.0375 0.2535)
+(0.0000 0.0375 0.2535)
+(0.0030 0.0375 0.2535)
+(0.0060 0.0375 0.2535)
+(-0.0060 0.0405 0.2535)
+(-0.0030 0.0405 0.2535)
+(0.0000 0.0405 0.2535)
+(0.0030 0.0405 0.2535)
+(0.0060 0.0405 0.2535)
+(-0.0060 0.0435 0.2535)
+(-0.0030 0.0435 0.2535)
+(0.0000 0.0435 0.2535)
+(0.0030 0.0435 0.2535)
+(0.0060 0.0435 0.2535)
+(-0.0060 0.0465 0.2535)
+(-0.0030 0.0465 0.2535)
+(0.0000 0.0465 0.2535)
+(0.0030 0.0465 0.2535)
+(0.0060 0.0465 0.2535)
+(-0.0060 0.0495 0.2535)
+(-0.0030 0.0495 0.2535)
+(0.0000 0.0495 0.2535)
+(0.0030 0.0495 0.2535)
+(0.0060 0.0495 0.2535)
+(-0.0060 0.0525 0.2535)
+(-0.0030 0.0525 0.2535)
+(0.0000 0.0525 0.2535)
+(0.0030 0.0525 0.2535)
+(0.0060 0.0525 0.2535)
+(-0.0060 0.0555 0.2535)
+(-0.0030 0.0555 0.2535)
+(0.0000 0.0555 0.2535)
+(0.0030 0.0555 0.2535)
+(0.0060 0.0555 0.2535)
+(-0.0060 0.0585 0.2535)
+(-0.0030 0.0585 0.2535)
+(0.0000 0.0585 0.2535)
+(0.0030 0.0585 0.2535)
+(0.0060 0.0585 0.2535)
+(-0.0060 0.0615 0.2535)
+(-0.0030 0.0615 0.2535)
+(0.0000 0.0615 0.2535)
+(0.0030 0.0615 0.2535)
+(0.0060 0.0615 0.2535)
+(-0.0060 0.0645 0.2535)
+(-0.0030 0.0645 0.2535)
+(0.0000 0.0645 0.2535)
+(0.0030 0.0645 0.2535)
+(0.0060 0.0645 0.2535)
+(-0.0060 0.0675 0.2535)
+(-0.0030 0.0675 0.2535)
+(0.0000 0.0675 0.2535)
+(0.0030 0.0675 0.2535)
+(0.0060 0.0675 0.2535)
+(-0.0060 0.0705 0.2535)
+(-0.0030 0.0705 0.2535)
+(0.0000 0.0705 0.2535)
+(0.0030 0.0705 0.2535)
+(0.0060 0.0705 0.2535)
+(-0.0060 0.0735 0.2535)
+(-0.0030 0.0735 0.2535)
+(0.0000 0.0735 0.2535)
+(0.0030 0.0735 0.2535)
+(0.0060 0.0735 0.2535)
+(-0.0060 -0.0735 0.2565)
+(-0.0030 -0.0735 0.2565)
+(0.0000 -0.0735 0.2565)
+(0.0030 -0.0735 0.2565)
+(0.0060 -0.0735 0.2565)
+(-0.0060 -0.0705 0.2565)
+(-0.0030 -0.0705 0.2565)
+(0.0000 -0.0705 0.2565)
+(0.0030 -0.0705 0.2565)
+(0.0060 -0.0705 0.2565)
+(-0.0060 -0.0675 0.2565)
+(-0.0030 -0.0675 0.2565)
+(0.0000 -0.0675 0.2565)
+(0.0030 -0.0675 0.2565)
+(0.0060 -0.0675 0.2565)
+(-0.0060 -0.0645 0.2565)
+(-0.0030 -0.0645 0.2565)
+(0.0000 -0.0645 0.2565)
+(0.0030 -0.0645 0.2565)
+(0.0060 -0.0645 0.2565)
+(-0.0060 -0.0615 0.2565)
+(-0.0030 -0.0615 0.2565)
+(0.0000 -0.0615 0.2565)
+(0.0030 -0.0615 0.2565)
+(0.0060 -0.0615 0.2565)
+(-0.0060 -0.0585 0.2565)
+(-0.0030 -0.0585 0.2565)
+(0.0000 -0.0585 0.2565)
+(0.0030 -0.0585 0.2565)
+(0.0060 -0.0585 0.2565)
+(-0.0060 -0.0555 0.2565)
+(-0.0030 -0.0555 0.2565)
+(0.0000 -0.0555 0.2565)
+(0.0030 -0.0555 0.2565)
+(0.0060 -0.0555 0.2565)
+(-0.0060 -0.0525 0.2565)
+(-0.0030 -0.0525 0.2565)
+(0.0000 -0.0525 0.2565)
+(0.0030 -0.0525 0.2565)
+(0.0060 -0.0525 0.2565)
+(-0.0060 -0.0495 0.2565)
+(-0.0030 -0.0495 0.2565)
+(0.0000 -0.0495 0.2565)
+(0.0030 -0.0495 0.2565)
+(0.0060 -0.0495 0.2565)
+(-0.0060 -0.0465 0.2565)
+(-0.0030 -0.0465 0.2565)
+(0.0000 -0.0465 0.2565)
+(0.0030 -0.0465 0.2565)
+(0.0060 -0.0465 0.2565)
+(-0.0060 -0.0435 0.2565)
+(-0.0030 -0.0435 0.2565)
+(0.0000 -0.0435 0.2565)
+(0.0030 -0.0435 0.2565)
+(0.0060 -0.0435 0.2565)
+(-0.0060 -0.0405 0.2565)
+(-0.0030 -0.0405 0.2565)
+(0.0000 -0.0405 0.2565)
+(0.0030 -0.0405 0.2565)
+(0.0060 -0.0405 0.2565)
+(-0.0060 -0.0375 0.2565)
+(-0.0030 -0.0375 0.2565)
+(0.0000 -0.0375 0.2565)
+(0.0030 -0.0375 0.2565)
+(0.0060 -0.0375 0.2565)
+(-0.0060 -0.0345 0.2565)
+(-0.0030 -0.0345 0.2565)
+(0.0000 -0.0345 0.2565)
+(0.0030 -0.0345 0.2565)
+(0.0060 -0.0345 0.2565)
+(-0.0060 -0.0315 0.2565)
+(-0.0030 -0.0315 0.2565)
+(0.0000 -0.0315 0.2565)
+(0.0030 -0.0315 0.2565)
+(0.0060 -0.0315 0.2565)
+(-0.0060 -0.0285 0.2565)
+(-0.0030 -0.0285 0.2565)
+(0.0000 -0.0285 0.2565)
+(0.0030 -0.0285 0.2565)
+(0.0060 -0.0285 0.2565)
+(-0.0060 -0.0255 0.2565)
+(-0.0030 -0.0255 0.2565)
+(0.0000 -0.0255 0.2565)
+(0.0030 -0.0255 0.2565)
+(0.0060 -0.0255 0.2565)
+(-0.0060 -0.0225 0.2565)
+(-0.0030 -0.0225 0.2565)
+(0.0000 -0.0225 0.2565)
+(0.0030 -0.0225 0.2565)
+(0.0060 -0.0225 0.2565)
+(-0.0060 -0.0195 0.2565)
+(-0.0030 -0.0195 0.2565)
+(0.0000 -0.0195 0.2565)
+(0.0030 -0.0195 0.2565)
+(0.0060 -0.0195 0.2565)
+(-0.0060 -0.0165 0.2565)
+(-0.0030 -0.0165 0.2565)
+(0.0000 -0.0165 0.2565)
+(0.0030 -0.0165 0.2565)
+(0.0060 -0.0165 0.2565)
+(-0.0060 -0.0135 0.2565)
+(-0.0030 -0.0135 0.2565)
+(0.0000 -0.0135 0.2565)
+(0.0030 -0.0135 0.2565)
+(0.0060 -0.0135 0.2565)
+(-0.0060 -0.0105 0.2565)
+(-0.0030 -0.0105 0.2565)
+(0.0000 -0.0105 0.2565)
+(0.0030 -0.0105 0.2565)
+(0.0060 -0.0105 0.2565)
+(-0.0060 -0.0075 0.2565)
+(-0.0030 -0.0075 0.2565)
+(0.0000 -0.0075 0.2565)
+(0.0030 -0.0075 0.2565)
+(0.0060 -0.0075 0.2565)
+(-0.0060 -0.0045 0.2565)
+(-0.0030 -0.0045 0.2565)
+(0.0000 -0.0045 0.2565)
+(0.0030 -0.0045 0.2565)
+(0.0060 -0.0045 0.2565)
+(-0.0060 -0.0015 0.2565)
+(-0.0030 -0.0015 0.2565)
+(0.0000 -0.0015 0.2565)
+(0.0030 -0.0015 0.2565)
+(0.0060 -0.0015 0.2565)
+(-0.0060 0.0015 0.2565)
+(-0.0030 0.0015 0.2565)
+(0.0000 0.0015 0.2565)
+(0.0030 0.0015 0.2565)
+(0.0060 0.0015 0.2565)
+(-0.0060 0.0045 0.2565)
+(-0.0030 0.0045 0.2565)
+(0.0000 0.0045 0.2565)
+(0.0030 0.0045 0.2565)
+(0.0060 0.0045 0.2565)
+(-0.0060 0.0075 0.2565)
+(-0.0030 0.0075 0.2565)
+(0.0000 0.0075 0.2565)
+(0.0030 0.0075 0.2565)
+(0.0060 0.0075 0.2565)
+(-0.0060 0.0105 0.2565)
+(-0.0030 0.0105 0.2565)
+(0.0000 0.0105 0.2565)
+(0.0030 0.0105 0.2565)
+(0.0060 0.0105 0.2565)
+(-0.0060 0.0135 0.2565)
+(-0.0030 0.0135 0.2565)
+(0.0000 0.0135 0.2565)
+(0.0030 0.0135 0.2565)
+(0.0060 0.0135 0.2565)
+(-0.0060 0.0165 0.2565)
+(-0.0030 0.0165 0.2565)
+(0.0000 0.0165 0.2565)
+(0.0030 0.0165 0.2565)
+(0.0060 0.0165 0.2565)
+(-0.0060 0.0195 0.2565)
+(-0.0030 0.0195 0.2565)
+(0.0000 0.0195 0.2565)
+(0.0030 0.0195 0.2565)
+(0.0060 0.0195 0.2565)
+(-0.0060 0.0225 0.2565)
+(-0.0030 0.0225 0.2565)
+(0.0000 0.0225 0.2565)
+(0.0030 0.0225 0.2565)
+(0.0060 0.0225 0.2565)
+(-0.0060 0.0255 0.2565)
+(-0.0030 0.0255 0.2565)
+(0.0000 0.0255 0.2565)
+(0.0030 0.0255 0.2565)
+(0.0060 0.0255 0.2565)
+(-0.0060 0.0285 0.2565)
+(-0.0030 0.0285 0.2565)
+(0.0000 0.0285 0.2565)
+(0.0030 0.0285 0.2565)
+(0.0060 0.0285 0.2565)
+(-0.0060 0.0315 0.2565)
+(-0.0030 0.0315 0.2565)
+(0.0000 0.0315 0.2565)
+(0.0030 0.0315 0.2565)
+(0.0060 0.0315 0.2565)
+(-0.0060 0.0345 0.2565)
+(-0.0030 0.0345 0.2565)
+(0.0000 0.0345 0.2565)
+(0.0030 0.0345 0.2565)
+(0.0060 0.0345 0.2565)
+(-0.0060 0.0375 0.2565)
+(-0.0030 0.0375 0.2565)
+(0.0000 0.0375 0.2565)
+(0.0030 0.0375 0.2565)
+(0.0060 0.0375 0.2565)
+(-0.0060 0.0405 0.2565)
+(-0.0030 0.0405 0.2565)
+(0.0000 0.0405 0.2565)
+(0.0030 0.0405 0.2565)
+(0.0060 0.0405 0.2565)
+(-0.0060 0.0435 0.2565)
+(-0.0030 0.0435 0.2565)
+(0.0000 0.0435 0.2565)
+(0.0030 0.0435 0.2565)
+(0.0060 0.0435 0.2565)
+(-0.0060 0.0465 0.2565)
+(-0.0030 0.0465 0.2565)
+(0.0000 0.0465 0.2565)
+(0.0030 0.0465 0.2565)
+(0.0060 0.0465 0.2565)
+(-0.0060 0.0495 0.2565)
+(-0.0030 0.0495 0.2565)
+(0.0000 0.0495 0.2565)
+(0.0030 0.0495 0.2565)
+(0.0060 0.0495 0.2565)
+(-0.0060 0.0525 0.2565)
+(-0.0030 0.0525 0.2565)
+(0.0000 0.0525 0.2565)
+(0.0030 0.0525 0.2565)
+(0.0060 0.0525 0.2565)
+(-0.0060 0.0555 0.2565)
+(-0.0030 0.0555 0.2565)
+(0.0000 0.0555 0.2565)
+(0.0030 0.0555 0.2565)
+(0.0060 0.0555 0.2565)
+(-0.0060 0.0585 0.2565)
+(-0.0030 0.0585 0.2565)
+(0.0000 0.0585 0.2565)
+(0.0030 0.0585 0.2565)
+(0.0060 0.0585 0.2565)
+(-0.0060 0.0615 0.2565)
+(-0.0030 0.0615 0.2565)
+(0.0000 0.0615 0.2565)
+(0.0030 0.0615 0.2565)
+(0.0060 0.0615 0.2565)
+(-0.0060 0.0645 0.2565)
+(-0.0030 0.0645 0.2565)
+(0.0000 0.0645 0.2565)
+(0.0030 0.0645 0.2565)
+(0.0060 0.0645 0.2565)
+(-0.0060 0.0675 0.2565)
+(-0.0030 0.0675 0.2565)
+(0.0000 0.0675 0.2565)
+(0.0030 0.0675 0.2565)
+(0.0060 0.0675 0.2565)
+(-0.0060 0.0705 0.2565)
+(-0.0030 0.0705 0.2565)
+(0.0000 0.0705 0.2565)
+(0.0030 0.0705 0.2565)
+(0.0060 0.0705 0.2565)
+(-0.0060 0.0735 0.2565)
+(-0.0030 0.0735 0.2565)
+(0.0000 0.0735 0.2565)
+(0.0030 0.0735 0.2565)
+(0.0060 0.0735 0.2565)
+(-0.0060 -0.0735 0.2595)
+(-0.0030 -0.0735 0.2595)
+(0.0000 -0.0735 0.2595)
+(0.0030 -0.0735 0.2595)
+(0.0060 -0.0735 0.2595)
+(-0.0060 -0.0705 0.2595)
+(-0.0030 -0.0705 0.2595)
+(0.0000 -0.0705 0.2595)
+(0.0030 -0.0705 0.2595)
+(0.0060 -0.0705 0.2595)
+(-0.0060 -0.0675 0.2595)
+(-0.0030 -0.0675 0.2595)
+(0.0000 -0.0675 0.2595)
+(0.0030 -0.0675 0.2595)
+(0.0060 -0.0675 0.2595)
+(-0.0060 -0.0645 0.2595)
+(-0.0030 -0.0645 0.2595)
+(0.0000 -0.0645 0.2595)
+(0.0030 -0.0645 0.2595)
+(0.0060 -0.0645 0.2595)
+(-0.0060 -0.0615 0.2595)
+(-0.0030 -0.0615 0.2595)
+(0.0000 -0.0615 0.2595)
+(0.0030 -0.0615 0.2595)
+(0.0060 -0.0615 0.2595)
+(-0.0060 -0.0585 0.2595)
+(-0.0030 -0.0585 0.2595)
+(0.0000 -0.0585 0.2595)
+(0.0030 -0.0585 0.2595)
+(0.0060 -0.0585 0.2595)
+(-0.0060 -0.0555 0.2595)
+(-0.0030 -0.0555 0.2595)
+(0.0000 -0.0555 0.2595)
+(0.0030 -0.0555 0.2595)
+(0.0060 -0.0555 0.2595)
+(-0.0060 -0.0525 0.2595)
+(-0.0030 -0.0525 0.2595)
+(0.0000 -0.0525 0.2595)
+(0.0030 -0.0525 0.2595)
+(0.0060 -0.0525 0.2595)
+(-0.0060 -0.0495 0.2595)
+(-0.0030 -0.0495 0.2595)
+(0.0000 -0.0495 0.2595)
+(0.0030 -0.0495 0.2595)
+(0.0060 -0.0495 0.2595)
+(-0.0060 -0.0465 0.2595)
+(-0.0030 -0.0465 0.2595)
+(0.0000 -0.0465 0.2595)
+(0.0030 -0.0465 0.2595)
+(0.0060 -0.0465 0.2595)
+(-0.0060 -0.0435 0.2595)
+(-0.0030 -0.0435 0.2595)
+(0.0000 -0.0435 0.2595)
+(0.0030 -0.0435 0.2595)
+(0.0060 -0.0435 0.2595)
+(-0.0060 -0.0405 0.2595)
+(-0.0030 -0.0405 0.2595)
+(0.0000 -0.0405 0.2595)
+(0.0030 -0.0405 0.2595)
+(0.0060 -0.0405 0.2595)
+(-0.0060 -0.0375 0.2595)
+(-0.0030 -0.0375 0.2595)
+(0.0000 -0.0375 0.2595)
+(0.0030 -0.0375 0.2595)
+(0.0060 -0.0375 0.2595)
+(-0.0060 -0.0345 0.2595)
+(-0.0030 -0.0345 0.2595)
+(0.0000 -0.0345 0.2595)
+(0.0030 -0.0345 0.2595)
+(0.0060 -0.0345 0.2595)
+(-0.0060 -0.0315 0.2595)
+(-0.0030 -0.0315 0.2595)
+(0.0000 -0.0315 0.2595)
+(0.0030 -0.0315 0.2595)
+(0.0060 -0.0315 0.2595)
+(-0.0060 -0.0285 0.2595)
+(-0.0030 -0.0285 0.2595)
+(0.0000 -0.0285 0.2595)
+(0.0030 -0.0285 0.2595)
+(0.0060 -0.0285 0.2595)
+(-0.0060 -0.0255 0.2595)
+(-0.0030 -0.0255 0.2595)
+(0.0000 -0.0255 0.2595)
+(0.0030 -0.0255 0.2595)
+(0.0060 -0.0255 0.2595)
+(-0.0060 -0.0225 0.2595)
+(-0.0030 -0.0225 0.2595)
+(0.0000 -0.0225 0.2595)
+(0.0030 -0.0225 0.2595)
+(0.0060 -0.0225 0.2595)
+(-0.0060 -0.0195 0.2595)
+(-0.0030 -0.0195 0.2595)
+(0.0000 -0.0195 0.2595)
+(0.0030 -0.0195 0.2595)
+(0.0060 -0.0195 0.2595)
+(-0.0060 -0.0165 0.2595)
+(-0.0030 -0.0165 0.2595)
+(0.0000 -0.0165 0.2595)
+(0.0030 -0.0165 0.2595)
+(0.0060 -0.0165 0.2595)
+(-0.0060 -0.0135 0.2595)
+(-0.0030 -0.0135 0.2595)
+(0.0000 -0.0135 0.2595)
+(0.0030 -0.0135 0.2595)
+(0.0060 -0.0135 0.2595)
+(-0.0060 -0.0105 0.2595)
+(-0.0030 -0.0105 0.2595)
+(0.0000 -0.0105 0.2595)
+(0.0030 -0.0105 0.2595)
+(0.0060 -0.0105 0.2595)
+(-0.0060 -0.0075 0.2595)
+(-0.0030 -0.0075 0.2595)
+(0.0000 -0.0075 0.2595)
+(0.0030 -0.0075 0.2595)
+(0.0060 -0.0075 0.2595)
+(-0.0060 -0.0045 0.2595)
+(-0.0030 -0.0045 0.2595)
+(0.0000 -0.0045 0.2595)
+(0.0030 -0.0045 0.2595)
+(0.0060 -0.0045 0.2595)
+(-0.0060 -0.0015 0.2595)
+(-0.0030 -0.0015 0.2595)
+(0.0000 -0.0015 0.2595)
+(0.0030 -0.0015 0.2595)
+(0.0060 -0.0015 0.2595)
+(-0.0060 0.0015 0.2595)
+(-0.0030 0.0015 0.2595)
+(0.0000 0.0015 0.2595)
+(0.0030 0.0015 0.2595)
+(0.0060 0.0015 0.2595)
+(-0.0060 0.0045 0.2595)
+(-0.0030 0.0045 0.2595)
+(0.0000 0.0045 0.2595)
+(0.0030 0.0045 0.2595)
+(0.0060 0.0045 0.2595)
+(-0.0060 0.0075 0.2595)
+(-0.0030 0.0075 0.2595)
+(0.0000 0.0075 0.2595)
+(0.0030 0.0075 0.2595)
+(0.0060 0.0075 0.2595)
+(-0.0060 0.0105 0.2595)
+(-0.0030 0.0105 0.2595)
+(0.0000 0.0105 0.2595)
+(0.0030 0.0105 0.2595)
+(0.0060 0.0105 0.2595)
+(-0.0060 0.0135 0.2595)
+(-0.0030 0.0135 0.2595)
+(0.0000 0.0135 0.2595)
+(0.0030 0.0135 0.2595)
+(0.0060 0.0135 0.2595)
+(-0.0060 0.0165 0.2595)
+(-0.0030 0.0165 0.2595)
+(0.0000 0.0165 0.2595)
+(0.0030 0.0165 0.2595)
+(0.0060 0.0165 0.2595)
+(-0.0060 0.0195 0.2595)
+(-0.0030 0.0195 0.2595)
+(0.0000 0.0195 0.2595)
+(0.0030 0.0195 0.2595)
+(0.0060 0.0195 0.2595)
+(-0.0060 0.0225 0.2595)
+(-0.0030 0.0225 0.2595)
+(0.0000 0.0225 0.2595)
+(0.0030 0.0225 0.2595)
+(0.0060 0.0225 0.2595)
+(-0.0060 0.0255 0.2595)
+(-0.0030 0.0255 0.2595)
+(0.0000 0.0255 0.2595)
+(0.0030 0.0255 0.2595)
+(0.0060 0.0255 0.2595)
+(-0.0060 0.0285 0.2595)
+(-0.0030 0.0285 0.2595)
+(0.0000 0.0285 0.2595)
+(0.0030 0.0285 0.2595)
+(0.0060 0.0285 0.2595)
+(-0.0060 0.0315 0.2595)
+(-0.0030 0.0315 0.2595)
+(0.0000 0.0315 0.2595)
+(0.0030 0.0315 0.2595)
+(0.0060 0.0315 0.2595)
+(-0.0060 0.0345 0.2595)
+(-0.0030 0.0345 0.2595)
+(0.0000 0.0345 0.2595)
+(0.0030 0.0345 0.2595)
+(0.0060 0.0345 0.2595)
+(-0.0060 0.0375 0.2595)
+(-0.0030 0.0375 0.2595)
+(0.0000 0.0375 0.2595)
+(0.0030 0.0375 0.2595)
+(0.0060 0.0375 0.2595)
+(-0.0060 0.0405 0.2595)
+(-0.0030 0.0405 0.2595)
+(0.0000 0.0405 0.2595)
+(0.0030 0.0405 0.2595)
+(0.0060 0.0405 0.2595)
+(-0.0060 0.0435 0.2595)
+(-0.0030 0.0435 0.2595)
+(0.0000 0.0435 0.2595)
+(0.0030 0.0435 0.2595)
+(0.0060 0.0435 0.2595)
+(-0.0060 0.0465 0.2595)
+(-0.0030 0.0465 0.2595)
+(0.0000 0.0465 0.2595)
+(0.0030 0.0465 0.2595)
+(0.0060 0.0465 0.2595)
+(-0.0060 0.0495 0.2595)
+(-0.0030 0.0495 0.2595)
+(0.0000 0.0495 0.2595)
+(0.0030 0.0495 0.2595)
+(0.0060 0.0495 0.2595)
+(-0.0060 0.0525 0.2595)
+(-0.0030 0.0525 0.2595)
+(0.0000 0.0525 0.2595)
+(0.0030 0.0525 0.2595)
+(0.0060 0.0525 0.2595)
+(-0.0060 0.0555 0.2595)
+(-0.0030 0.0555 0.2595)
+(0.0000 0.0555 0.2595)
+(0.0030 0.0555 0.2595)
+(0.0060 0.0555 0.2595)
+(-0.0060 0.0585 0.2595)
+(-0.0030 0.0585 0.2595)
+(0.0000 0.0585 0.2595)
+(0.0030 0.0585 0.2595)
+(0.0060 0.0585 0.2595)
+(-0.0060 0.0615 0.2595)
+(-0.0030 0.0615 0.2595)
+(0.0000 0.0615 0.2595)
+(0.0030 0.0615 0.2595)
+(0.0060 0.0615 0.2595)
+(-0.0060 0.0645 0.2595)
+(-0.0030 0.0645 0.2595)
+(0.0000 0.0645 0.2595)
+(0.0030 0.0645 0.2595)
+(0.0060 0.0645 0.2595)
+(-0.0060 0.0675 0.2595)
+(-0.0030 0.0675 0.2595)
+(0.0000 0.0675 0.2595)
+(0.0030 0.0675 0.2595)
+(0.0060 0.0675 0.2595)
+(-0.0060 0.0705 0.2595)
+(-0.0030 0.0705 0.2595)
+(0.0000 0.0705 0.2595)
+(0.0030 0.0705 0.2595)
+(0.0060 0.0705 0.2595)
+(-0.0060 0.0735 0.2595)
+(-0.0030 0.0735 0.2595)
+(0.0000 0.0735 0.2595)
+(0.0030 0.0735 0.2595)
+(0.0060 0.0735 0.2595)
+(-0.0060 -0.0735 0.2625)
+(-0.0030 -0.0735 0.2625)
+(0.0000 -0.0735 0.2625)
+(0.0030 -0.0735 0.2625)
+(0.0060 -0.0735 0.2625)
+(-0.0060 -0.0705 0.2625)
+(-0.0030 -0.0705 0.2625)
+(0.0000 -0.0705 0.2625)
+(0.0030 -0.0705 0.2625)
+(0.0060 -0.0705 0.2625)
+(-0.0060 -0.0675 0.2625)
+(-0.0030 -0.0675 0.2625)
+(0.0000 -0.0675 0.2625)
+(0.0030 -0.0675 0.2625)
+(0.0060 -0.0675 0.2625)
+(-0.0060 -0.0645 0.2625)
+(-0.0030 -0.0645 0.2625)
+(0.0000 -0.0645 0.2625)
+(0.0030 -0.0645 0.2625)
+(0.0060 -0.0645 0.2625)
+(-0.0060 -0.0615 0.2625)
+(-0.0030 -0.0615 0.2625)
+(0.0000 -0.0615 0.2625)
+(0.0030 -0.0615 0.2625)
+(0.0060 -0.0615 0.2625)
+(-0.0060 -0.0585 0.2625)
+(-0.0030 -0.0585 0.2625)
+(0.0000 -0.0585 0.2625)
+(0.0030 -0.0585 0.2625)
+(0.0060 -0.0585 0.2625)
+(-0.0060 -0.0555 0.2625)
+(-0.0030 -0.0555 0.2625)
+(0.0000 -0.0555 0.2625)
+(0.0030 -0.0555 0.2625)
+(0.0060 -0.0555 0.2625)
+(-0.0060 -0.0525 0.2625)
+(-0.0030 -0.0525 0.2625)
+(0.0000 -0.0525 0.2625)
+(0.0030 -0.0525 0.2625)
+(0.0060 -0.0525 0.2625)
+(-0.0060 -0.0495 0.2625)
+(-0.0030 -0.0495 0.2625)
+(0.0000 -0.0495 0.2625)
+(0.0030 -0.0495 0.2625)
+(0.0060 -0.0495 0.2625)
+(-0.0060 -0.0465 0.2625)
+(-0.0030 -0.0465 0.2625)
+(0.0000 -0.0465 0.2625)
+(0.0030 -0.0465 0.2625)
+(0.0060 -0.0465 0.2625)
+(-0.0060 -0.0435 0.2625)
+(-0.0030 -0.0435 0.2625)
+(0.0000 -0.0435 0.2625)
+(0.0030 -0.0435 0.2625)
+(0.0060 -0.0435 0.2625)
+(-0.0060 -0.0405 0.2625)
+(-0.0030 -0.0405 0.2625)
+(0.0000 -0.0405 0.2625)
+(0.0030 -0.0405 0.2625)
+(0.0060 -0.0405 0.2625)
+(-0.0060 -0.0375 0.2625)
+(-0.0030 -0.0375 0.2625)
+(0.0000 -0.0375 0.2625)
+(0.0030 -0.0375 0.2625)
+(0.0060 -0.0375 0.2625)
+(-0.0060 -0.0345 0.2625)
+(-0.0030 -0.0345 0.2625)
+(0.0000 -0.0345 0.2625)
+(0.0030 -0.0345 0.2625)
+(0.0060 -0.0345 0.2625)
+(-0.0060 -0.0315 0.2625)
+(-0.0030 -0.0315 0.2625)
+(0.0000 -0.0315 0.2625)
+(0.0030 -0.0315 0.2625)
+(0.0060 -0.0315 0.2625)
+(-0.0060 -0.0285 0.2625)
+(-0.0030 -0.0285 0.2625)
+(0.0000 -0.0285 0.2625)
+(0.0030 -0.0285 0.2625)
+(0.0060 -0.0285 0.2625)
+(-0.0060 -0.0255 0.2625)
+(-0.0030 -0.0255 0.2625)
+(0.0000 -0.0255 0.2625)
+(0.0030 -0.0255 0.2625)
+(0.0060 -0.0255 0.2625)
+(-0.0060 -0.0225 0.2625)
+(-0.0030 -0.0225 0.2625)
+(0.0000 -0.0225 0.2625)
+(0.0030 -0.0225 0.2625)
+(0.0060 -0.0225 0.2625)
+(-0.0060 -0.0195 0.2625)
+(-0.0030 -0.0195 0.2625)
+(0.0000 -0.0195 0.2625)
+(0.0030 -0.0195 0.2625)
+(0.0060 -0.0195 0.2625)
+(-0.0060 -0.0165 0.2625)
+(-0.0030 -0.0165 0.2625)
+(0.0000 -0.0165 0.2625)
+(0.0030 -0.0165 0.2625)
+(0.0060 -0.0165 0.2625)
+(-0.0060 -0.0135 0.2625)
+(-0.0030 -0.0135 0.2625)
+(0.0000 -0.0135 0.2625)
+(0.0030 -0.0135 0.2625)
+(0.0060 -0.0135 0.2625)
+(-0.0060 -0.0105 0.2625)
+(-0.0030 -0.0105 0.2625)
+(0.0000 -0.0105 0.2625)
+(0.0030 -0.0105 0.2625)
+(0.0060 -0.0105 0.2625)
+(-0.0060 -0.0075 0.2625)
+(-0.0030 -0.0075 0.2625)
+(0.0000 -0.0075 0.2625)
+(0.0030 -0.0075 0.2625)
+(0.0060 -0.0075 0.2625)
+(-0.0060 -0.0045 0.2625)
+(-0.0030 -0.0045 0.2625)
+(0.0000 -0.0045 0.2625)
+(0.0030 -0.0045 0.2625)
+(0.0060 -0.0045 0.2625)
+(-0.0060 -0.0015 0.2625)
+(-0.0030 -0.0015 0.2625)
+(0.0000 -0.0015 0.2625)
+(0.0030 -0.0015 0.2625)
+(0.0060 -0.0015 0.2625)
+(-0.0060 0.0015 0.2625)
+(-0.0030 0.0015 0.2625)
+(0.0000 0.0015 0.2625)
+(0.0030 0.0015 0.2625)
+(0.0060 0.0015 0.2625)
+(-0.0060 0.0045 0.2625)
+(-0.0030 0.0045 0.2625)
+(0.0000 0.0045 0.2625)
+(0.0030 0.0045 0.2625)
+(0.0060 0.0045 0.2625)
+(-0.0060 0.0075 0.2625)
+(-0.0030 0.0075 0.2625)
+(0.0000 0.0075 0.2625)
+(0.0030 0.0075 0.2625)
+(0.0060 0.0075 0.2625)
+(-0.0060 0.0105 0.2625)
+(-0.0030 0.0105 0.2625)
+(0.0000 0.0105 0.2625)
+(0.0030 0.0105 0.2625)
+(0.0060 0.0105 0.2625)
+(-0.0060 0.0135 0.2625)
+(-0.0030 0.0135 0.2625)
+(0.0000 0.0135 0.2625)
+(0.0030 0.0135 0.2625)
+(0.0060 0.0135 0.2625)
+(-0.0060 0.0165 0.2625)
+(-0.0030 0.0165 0.2625)
+(0.0000 0.0165 0.2625)
+(0.0030 0.0165 0.2625)
+(0.0060 0.0165 0.2625)
+(-0.0060 0.0195 0.2625)
+(-0.0030 0.0195 0.2625)
+(0.0000 0.0195 0.2625)
+(0.0030 0.0195 0.2625)
+(0.0060 0.0195 0.2625)
+(-0.0060 0.0225 0.2625)
+(-0.0030 0.0225 0.2625)
+(0.0000 0.0225 0.2625)
+(0.0030 0.0225 0.2625)
+(0.0060 0.0225 0.2625)
+(-0.0060 0.0255 0.2625)
+(-0.0030 0.0255 0.2625)
+(0.0000 0.0255 0.2625)
+(0.0030 0.0255 0.2625)
+(0.0060 0.0255 0.2625)
+(-0.0060 0.0285 0.2625)
+(-0.0030 0.0285 0.2625)
+(0.0000 0.0285 0.2625)
+(0.0030 0.0285 0.2625)
+(0.0060 0.0285 0.2625)
+(-0.0060 0.0315 0.2625)
+(-0.0030 0.0315 0.2625)
+(0.0000 0.0315 0.2625)
+(0.0030 0.0315 0.2625)
+(0.0060 0.0315 0.2625)
+(-0.0060 0.0345 0.2625)
+(-0.0030 0.0345 0.2625)
+(0.0000 0.0345 0.2625)
+(0.0030 0.0345 0.2625)
+(0.0060 0.0345 0.2625)
+(-0.0060 0.0375 0.2625)
+(-0.0030 0.0375 0.2625)
+(0.0000 0.0375 0.2625)
+(0.0030 0.0375 0.2625)
+(0.0060 0.0375 0.2625)
+(-0.0060 0.0405 0.2625)
+(-0.0030 0.0405 0.2625)
+(0.0000 0.0405 0.2625)
+(0.0030 0.0405 0.2625)
+(0.0060 0.0405 0.2625)
+(-0.0060 0.0435 0.2625)
+(-0.0030 0.0435 0.2625)
+(0.0000 0.0435 0.2625)
+(0.0030 0.0435 0.2625)
+(0.0060 0.0435 0.2625)
+(-0.0060 0.0465 0.2625)
+(-0.0030 0.0465 0.2625)
+(0.0000 0.0465 0.2625)
+(0.0030 0.0465 0.2625)
+(0.0060 0.0465 0.2625)
+(-0.0060 0.0495 0.2625)
+(-0.0030 0.0495 0.2625)
+(0.0000 0.0495 0.2625)
+(0.0030 0.0495 0.2625)
+(0.0060 0.0495 0.2625)
+(-0.0060 0.0525 0.2625)
+(-0.0030 0.0525 0.2625)
+(0.0000 0.0525 0.2625)
+(0.0030 0.0525 0.2625)
+(0.0060 0.0525 0.2625)
+(-0.0060 0.0555 0.2625)
+(-0.0030 0.0555 0.2625)
+(0.0000 0.0555 0.2625)
+(0.0030 0.0555 0.2625)
+(0.0060 0.0555 0.2625)
+(-0.0060 0.0585 0.2625)
+(-0.0030 0.0585 0.2625)
+(0.0000 0.0585 0.2625)
+(0.0030 0.0585 0.2625)
+(0.0060 0.0585 0.2625)
+(-0.0060 0.0615 0.2625)
+(-0.0030 0.0615 0.2625)
+(0.0000 0.0615 0.2625)
+(0.0030 0.0615 0.2625)
+(0.0060 0.0615 0.2625)
+(-0.0060 0.0645 0.2625)
+(-0.0030 0.0645 0.2625)
+(0.0000 0.0645 0.2625)
+(0.0030 0.0645 0.2625)
+(0.0060 0.0645 0.2625)
+(-0.0060 0.0675 0.2625)
+(-0.0030 0.0675 0.2625)
+(0.0000 0.0675 0.2625)
+(0.0030 0.0675 0.2625)
+(0.0060 0.0675 0.2625)
+(-0.0060 0.0705 0.2625)
+(-0.0030 0.0705 0.2625)
+(0.0000 0.0705 0.2625)
+(0.0030 0.0705 0.2625)
+(0.0060 0.0705 0.2625)
+(-0.0060 0.0735 0.2625)
+(-0.0030 0.0735 0.2625)
+(0.0000 0.0735 0.2625)
+(0.0030 0.0735 0.2625)
+(0.0060 0.0735 0.2625)
+(-0.0060 -0.0735 0.2655)
+(-0.0030 -0.0735 0.2655)
+(0.0000 -0.0735 0.2655)
+(0.0030 -0.0735 0.2655)
+(0.0060 -0.0735 0.2655)
+(-0.0060 -0.0705 0.2655)
+(-0.0030 -0.0705 0.2655)
+(0.0000 -0.0705 0.2655)
+(0.0030 -0.0705 0.2655)
+(0.0060 -0.0705 0.2655)
+(-0.0060 -0.0675 0.2655)
+(-0.0030 -0.0675 0.2655)
+(0.0000 -0.0675 0.2655)
+(0.0030 -0.0675 0.2655)
+(0.0060 -0.0675 0.2655)
+(-0.0060 -0.0645 0.2655)
+(-0.0030 -0.0645 0.2655)
+(0.0000 -0.0645 0.2655)
+(0.0030 -0.0645 0.2655)
+(0.0060 -0.0645 0.2655)
+(-0.0060 -0.0615 0.2655)
+(-0.0030 -0.0615 0.2655)
+(0.0000 -0.0615 0.2655)
+(0.0030 -0.0615 0.2655)
+(0.0060 -0.0615 0.2655)
+(-0.0060 -0.0585 0.2655)
+(-0.0030 -0.0585 0.2655)
+(0.0000 -0.0585 0.2655)
+(0.0030 -0.0585 0.2655)
+(0.0060 -0.0585 0.2655)
+(-0.0060 -0.0555 0.2655)
+(-0.0030 -0.0555 0.2655)
+(0.0000 -0.0555 0.2655)
+(0.0030 -0.0555 0.2655)
+(0.0060 -0.0555 0.2655)
+(-0.0060 -0.0525 0.2655)
+(-0.0030 -0.0525 0.2655)
+(0.0000 -0.0525 0.2655)
+(0.0030 -0.0525 0.2655)
+(0.0060 -0.0525 0.2655)
+(-0.0060 -0.0495 0.2655)
+(-0.0030 -0.0495 0.2655)
+(0.0000 -0.0495 0.2655)
+(0.0030 -0.0495 0.2655)
+(0.0060 -0.0495 0.2655)
+(-0.0060 -0.0465 0.2655)
+(-0.0030 -0.0465 0.2655)
+(0.0000 -0.0465 0.2655)
+(0.0030 -0.0465 0.2655)
+(0.0060 -0.0465 0.2655)
+(-0.0060 -0.0435 0.2655)
+(-0.0030 -0.0435 0.2655)
+(0.0000 -0.0435 0.2655)
+(0.0030 -0.0435 0.2655)
+(0.0060 -0.0435 0.2655)
+(-0.0060 -0.0405 0.2655)
+(-0.0030 -0.0405 0.2655)
+(0.0000 -0.0405 0.2655)
+(0.0030 -0.0405 0.2655)
+(0.0060 -0.0405 0.2655)
+(-0.0060 -0.0375 0.2655)
+(-0.0030 -0.0375 0.2655)
+(0.0000 -0.0375 0.2655)
+(0.0030 -0.0375 0.2655)
+(0.0060 -0.0375 0.2655)
+(-0.0060 -0.0345 0.2655)
+(-0.0030 -0.0345 0.2655)
+(0.0000 -0.0345 0.2655)
+(0.0030 -0.0345 0.2655)
+(0.0060 -0.0345 0.2655)
+(-0.0060 -0.0315 0.2655)
+(-0.0030 -0.0315 0.2655)
+(0.0000 -0.0315 0.2655)
+(0.0030 -0.0315 0.2655)
+(0.0060 -0.0315 0.2655)
+(-0.0060 -0.0285 0.2655)
+(-0.0030 -0.0285 0.2655)
+(0.0000 -0.0285 0.2655)
+(0.0030 -0.0285 0.2655)
+(0.0060 -0.0285 0.2655)
+(-0.0060 -0.0255 0.2655)
+(-0.0030 -0.0255 0.2655)
+(0.0000 -0.0255 0.2655)
+(0.0030 -0.0255 0.2655)
+(0.0060 -0.0255 0.2655)
+(-0.0060 -0.0225 0.2655)
+(-0.0030 -0.0225 0.2655)
+(0.0000 -0.0225 0.2655)
+(0.0030 -0.0225 0.2655)
+(0.0060 -0.0225 0.2655)
+(-0.0060 -0.0195 0.2655)
+(-0.0030 -0.0195 0.2655)
+(0.0000 -0.0195 0.2655)
+(0.0030 -0.0195 0.2655)
+(0.0060 -0.0195 0.2655)
+(-0.0060 -0.0165 0.2655)
+(-0.0030 -0.0165 0.2655)
+(0.0000 -0.0165 0.2655)
+(0.0030 -0.0165 0.2655)
+(0.0060 -0.0165 0.2655)
+(-0.0060 -0.0135 0.2655)
+(-0.0030 -0.0135 0.2655)
+(0.0000 -0.0135 0.2655)
+(0.0030 -0.0135 0.2655)
+(0.0060 -0.0135 0.2655)
+(-0.0060 -0.0105 0.2655)
+(-0.0030 -0.0105 0.2655)
+(0.0000 -0.0105 0.2655)
+(0.0030 -0.0105 0.2655)
+(0.0060 -0.0105 0.2655)
+(-0.0060 -0.0075 0.2655)
+(-0.0030 -0.0075 0.2655)
+(0.0000 -0.0075 0.2655)
+(0.0030 -0.0075 0.2655)
+(0.0060 -0.0075 0.2655)
+(-0.0060 -0.0045 0.2655)
+(-0.0030 -0.0045 0.2655)
+(0.0000 -0.0045 0.2655)
+(0.0030 -0.0045 0.2655)
+(0.0060 -0.0045 0.2655)
+(-0.0060 -0.0015 0.2655)
+(-0.0030 -0.0015 0.2655)
+(0.0000 -0.0015 0.2655)
+(0.0030 -0.0015 0.2655)
+(0.0060 -0.0015 0.2655)
+(-0.0060 0.0015 0.2655)
+(-0.0030 0.0015 0.2655)
+(0.0000 0.0015 0.2655)
+(0.0030 0.0015 0.2655)
+(0.0060 0.0015 0.2655)
+(-0.0060 0.0045 0.2655)
+(-0.0030 0.0045 0.2655)
+(0.0000 0.0045 0.2655)
+(0.0030 0.0045 0.2655)
+(0.0060 0.0045 0.2655)
+(-0.0060 0.0075 0.2655)
+(-0.0030 0.0075 0.2655)
+(0.0000 0.0075 0.2655)
+(0.0030 0.0075 0.2655)
+(0.0060 0.0075 0.2655)
+(-0.0060 0.0105 0.2655)
+(-0.0030 0.0105 0.2655)
+(0.0000 0.0105 0.2655)
+(0.0030 0.0105 0.2655)
+(0.0060 0.0105 0.2655)
+(-0.0060 0.0135 0.2655)
+(-0.0030 0.0135 0.2655)
+(0.0000 0.0135 0.2655)
+(0.0030 0.0135 0.2655)
+(0.0060 0.0135 0.2655)
+(-0.0060 0.0165 0.2655)
+(-0.0030 0.0165 0.2655)
+(0.0000 0.0165 0.2655)
+(0.0030 0.0165 0.2655)
+(0.0060 0.0165 0.2655)
+(-0.0060 0.0195 0.2655)
+(-0.0030 0.0195 0.2655)
+(0.0000 0.0195 0.2655)
+(0.0030 0.0195 0.2655)
+(0.0060 0.0195 0.2655)
+(-0.0060 0.0225 0.2655)
+(-0.0030 0.0225 0.2655)
+(0.0000 0.0225 0.2655)
+(0.0030 0.0225 0.2655)
+(0.0060 0.0225 0.2655)
+(-0.0060 0.0255 0.2655)
+(-0.0030 0.0255 0.2655)
+(0.0000 0.0255 0.2655)
+(0.0030 0.0255 0.2655)
+(0.0060 0.0255 0.2655)
+(-0.0060 0.0285 0.2655)
+(-0.0030 0.0285 0.2655)
+(0.0000 0.0285 0.2655)
+(0.0030 0.0285 0.2655)
+(0.0060 0.0285 0.2655)
+(-0.0060 0.0315 0.2655)
+(-0.0030 0.0315 0.2655)
+(0.0000 0.0315 0.2655)
+(0.0030 0.0315 0.2655)
+(0.0060 0.0315 0.2655)
+(-0.0060 0.0345 0.2655)
+(-0.0030 0.0345 0.2655)
+(0.0000 0.0345 0.2655)
+(0.0030 0.0345 0.2655)
+(0.0060 0.0345 0.2655)
+(-0.0060 0.0375 0.2655)
+(-0.0030 0.0375 0.2655)
+(0.0000 0.0375 0.2655)
+(0.0030 0.0375 0.2655)
+(0.0060 0.0375 0.2655)
+(-0.0060 0.0405 0.2655)
+(-0.0030 0.0405 0.2655)
+(0.0000 0.0405 0.2655)
+(0.0030 0.0405 0.2655)
+(0.0060 0.0405 0.2655)
+(-0.0060 0.0435 0.2655)
+(-0.0030 0.0435 0.2655)
+(0.0000 0.0435 0.2655)
+(0.0030 0.0435 0.2655)
+(0.0060 0.0435 0.2655)
+(-0.0060 0.0465 0.2655)
+(-0.0030 0.0465 0.2655)
+(0.0000 0.0465 0.2655)
+(0.0030 0.0465 0.2655)
+(0.0060 0.0465 0.2655)
+(-0.0060 0.0495 0.2655)
+(-0.0030 0.0495 0.2655)
+(0.0000 0.0495 0.2655)
+(0.0030 0.0495 0.2655)
+(0.0060 0.0495 0.2655)
+(-0.0060 0.0525 0.2655)
+(-0.0030 0.0525 0.2655)
+(0.0000 0.0525 0.2655)
+(0.0030 0.0525 0.2655)
+(0.0060 0.0525 0.2655)
+(-0.0060 0.0555 0.2655)
+(-0.0030 0.0555 0.2655)
+(0.0000 0.0555 0.2655)
+(0.0030 0.0555 0.2655)
+(0.0060 0.0555 0.2655)
+(-0.0060 0.0585 0.2655)
+(-0.0030 0.0585 0.2655)
+(0.0000 0.0585 0.2655)
+(0.0030 0.0585 0.2655)
+(0.0060 0.0585 0.2655)
+(-0.0060 0.0615 0.2655)
+(-0.0030 0.0615 0.2655)
+(0.0000 0.0615 0.2655)
+(0.0030 0.0615 0.2655)
+(0.0060 0.0615 0.2655)
+(-0.0060 0.0645 0.2655)
+(-0.0030 0.0645 0.2655)
+(0.0000 0.0645 0.2655)
+(0.0030 0.0645 0.2655)
+(0.0060 0.0645 0.2655)
+(-0.0060 0.0675 0.2655)
+(-0.0030 0.0675 0.2655)
+(0.0000 0.0675 0.2655)
+(0.0030 0.0675 0.2655)
+(0.0060 0.0675 0.2655)
+(-0.0060 0.0705 0.2655)
+(-0.0030 0.0705 0.2655)
+(0.0000 0.0705 0.2655)
+(0.0030 0.0705 0.2655)
+(0.0060 0.0705 0.2655)
+(-0.0060 0.0735 0.2655)
+(-0.0030 0.0735 0.2655)
+(0.0000 0.0735 0.2655)
+(0.0030 0.0735 0.2655)
+(0.0060 0.0735 0.2655)
+(-0.0060 -0.0735 0.2685)
+(-0.0030 -0.0735 0.2685)
+(0.0000 -0.0735 0.2685)
+(0.0030 -0.0735 0.2685)
+(0.0060 -0.0735 0.2685)
+(-0.0060 -0.0705 0.2685)
+(-0.0030 -0.0705 0.2685)
+(0.0000 -0.0705 0.2685)
+(0.0030 -0.0705 0.2685)
+(0.0060 -0.0705 0.2685)
+(-0.0060 -0.0675 0.2685)
+(-0.0030 -0.0675 0.2685)
+(0.0000 -0.0675 0.2685)
+(0.0030 -0.0675 0.2685)
+(0.0060 -0.0675 0.2685)
+(-0.0060 -0.0645 0.2685)
+(-0.0030 -0.0645 0.2685)
+(0.0000 -0.0645 0.2685)
+(0.0030 -0.0645 0.2685)
+(0.0060 -0.0645 0.2685)
+(-0.0060 -0.0615 0.2685)
+(-0.0030 -0.0615 0.2685)
+(0.0000 -0.0615 0.2685)
+(0.0030 -0.0615 0.2685)
+(0.0060 -0.0615 0.2685)
+(-0.0060 -0.0585 0.2685)
+(-0.0030 -0.0585 0.2685)
+(0.0000 -0.0585 0.2685)
+(0.0030 -0.0585 0.2685)
+(0.0060 -0.0585 0.2685)
+(-0.0060 -0.0555 0.2685)
+(-0.0030 -0.0555 0.2685)
+(0.0000 -0.0555 0.2685)
+(0.0030 -0.0555 0.2685)
+(0.0060 -0.0555 0.2685)
+(-0.0060 -0.0525 0.2685)
+(-0.0030 -0.0525 0.2685)
+(0.0000 -0.0525 0.2685)
+(0.0030 -0.0525 0.2685)
+(0.0060 -0.0525 0.2685)
+(-0.0060 -0.0495 0.2685)
+(-0.0030 -0.0495 0.2685)
+(0.0000 -0.0495 0.2685)
+(0.0030 -0.0495 0.2685)
+(0.0060 -0.0495 0.2685)
+(-0.0060 -0.0465 0.2685)
+(-0.0030 -0.0465 0.2685)
+(0.0000 -0.0465 0.2685)
+(0.0030 -0.0465 0.2685)
+(0.0060 -0.0465 0.2685)
+(-0.0060 -0.0435 0.2685)
+(-0.0030 -0.0435 0.2685)
+(0.0000 -0.0435 0.2685)
+(0.0030 -0.0435 0.2685)
+(0.0060 -0.0435 0.2685)
+(-0.0060 -0.0405 0.2685)
+(-0.0030 -0.0405 0.2685)
+(0.0000 -0.0405 0.2685)
+(0.0030 -0.0405 0.2685)
+(0.0060 -0.0405 0.2685)
+(-0.0060 -0.0375 0.2685)
+(-0.0030 -0.0375 0.2685)
+(0.0000 -0.0375 0.2685)
+(0.0030 -0.0375 0.2685)
+(0.0060 -0.0375 0.2685)
+(-0.0060 -0.0345 0.2685)
+(-0.0030 -0.0345 0.2685)
+(0.0000 -0.0345 0.2685)
+(0.0030 -0.0345 0.2685)
+(0.0060 -0.0345 0.2685)
+(-0.0060 -0.0315 0.2685)
+(-0.0030 -0.0315 0.2685)
+(0.0000 -0.0315 0.2685)
+(0.0030 -0.0315 0.2685)
+(0.0060 -0.0315 0.2685)
+(-0.0060 -0.0285 0.2685)
+(-0.0030 -0.0285 0.2685)
+(0.0000 -0.0285 0.2685)
+(0.0030 -0.0285 0.2685)
+(0.0060 -0.0285 0.2685)
+(-0.0060 -0.0255 0.2685)
+(-0.0030 -0.0255 0.2685)
+(0.0000 -0.0255 0.2685)
+(0.0030 -0.0255 0.2685)
+(0.0060 -0.0255 0.2685)
+(-0.0060 -0.0225 0.2685)
+(-0.0030 -0.0225 0.2685)
+(0.0000 -0.0225 0.2685)
+(0.0030 -0.0225 0.2685)
+(0.0060 -0.0225 0.2685)
+(-0.0060 -0.0195 0.2685)
+(-0.0030 -0.0195 0.2685)
+(0.0000 -0.0195 0.2685)
+(0.0030 -0.0195 0.2685)
+(0.0060 -0.0195 0.2685)
+(-0.0060 -0.0165 0.2685)
+(-0.0030 -0.0165 0.2685)
+(0.0000 -0.0165 0.2685)
+(0.0030 -0.0165 0.2685)
+(0.0060 -0.0165 0.2685)
+(-0.0060 -0.0135 0.2685)
+(-0.0030 -0.0135 0.2685)
+(0.0000 -0.0135 0.2685)
+(0.0030 -0.0135 0.2685)
+(0.0060 -0.0135 0.2685)
+(-0.0060 -0.0105 0.2685)
+(-0.0030 -0.0105 0.2685)
+(0.0000 -0.0105 0.2685)
+(0.0030 -0.0105 0.2685)
+(0.0060 -0.0105 0.2685)
+(-0.0060 -0.0075 0.2685)
+(-0.0030 -0.0075 0.2685)
+(0.0000 -0.0075 0.2685)
+(0.0030 -0.0075 0.2685)
+(0.0060 -0.0075 0.2685)
+(-0.0060 -0.0045 0.2685)
+(-0.0030 -0.0045 0.2685)
+(0.0000 -0.0045 0.2685)
+(0.0030 -0.0045 0.2685)
+(0.0060 -0.0045 0.2685)
+(-0.0060 -0.0015 0.2685)
+(-0.0030 -0.0015 0.2685)
+(0.0000 -0.0015 0.2685)
+(0.0030 -0.0015 0.2685)
+(0.0060 -0.0015 0.2685)
+(-0.0060 0.0015 0.2685)
+(-0.0030 0.0015 0.2685)
+(0.0000 0.0015 0.2685)
+(0.0030 0.0015 0.2685)
+(0.0060 0.0015 0.2685)
+(-0.0060 0.0045 0.2685)
+(-0.0030 0.0045 0.2685)
+(0.0000 0.0045 0.2685)
+(0.0030 0.0045 0.2685)
+(0.0060 0.0045 0.2685)
+(-0.0060 0.0075 0.2685)
+(-0.0030 0.0075 0.2685)
+(0.0000 0.0075 0.2685)
+(0.0030 0.0075 0.2685)
+(0.0060 0.0075 0.2685)
+(-0.0060 0.0105 0.2685)
+(-0.0030 0.0105 0.2685)
+(0.0000 0.0105 0.2685)
+(0.0030 0.0105 0.2685)
+(0.0060 0.0105 0.2685)
+(-0.0060 0.0135 0.2685)
+(-0.0030 0.0135 0.2685)
+(0.0000 0.0135 0.2685)
+(0.0030 0.0135 0.2685)
+(0.0060 0.0135 0.2685)
+(-0.0060 0.0165 0.2685)
+(-0.0030 0.0165 0.2685)
+(0.0000 0.0165 0.2685)
+(0.0030 0.0165 0.2685)
+(0.0060 0.0165 0.2685)
+(-0.0060 0.0195 0.2685)
+(-0.0030 0.0195 0.2685)
+(0.0000 0.0195 0.2685)
+(0.0030 0.0195 0.2685)
+(0.0060 0.0195 0.2685)
+(-0.0060 0.0225 0.2685)
+(-0.0030 0.0225 0.2685)
+(0.0000 0.0225 0.2685)
+(0.0030 0.0225 0.2685)
+(0.0060 0.0225 0.2685)
+(-0.0060 0.0255 0.2685)
+(-0.0030 0.0255 0.2685)
+(0.0000 0.0255 0.2685)
+(0.0030 0.0255 0.2685)
+(0.0060 0.0255 0.2685)
+(-0.0060 0.0285 0.2685)
+(-0.0030 0.0285 0.2685)
+(0.0000 0.0285 0.2685)
+(0.0030 0.0285 0.2685)
+(0.0060 0.0285 0.2685)
+(-0.0060 0.0315 0.2685)
+(-0.0030 0.0315 0.2685)
+(0.0000 0.0315 0.2685)
+(0.0030 0.0315 0.2685)
+(0.0060 0.0315 0.2685)
+(-0.0060 0.0345 0.2685)
+(-0.0030 0.0345 0.2685)
+(0.0000 0.0345 0.2685)
+(0.0030 0.0345 0.2685)
+(0.0060 0.0345 0.2685)
+(-0.0060 0.0375 0.2685)
+(-0.0030 0.0375 0.2685)
+(0.0000 0.0375 0.2685)
+(0.0030 0.0375 0.2685)
+(0.0060 0.0375 0.2685)
+(-0.0060 0.0405 0.2685)
+(-0.0030 0.0405 0.2685)
+(0.0000 0.0405 0.2685)
+(0.0030 0.0405 0.2685)
+(0.0060 0.0405 0.2685)
+(-0.0060 0.0435 0.2685)
+(-0.0030 0.0435 0.2685)
+(0.0000 0.0435 0.2685)
+(0.0030 0.0435 0.2685)
+(0.0060 0.0435 0.2685)
+(-0.0060 0.0465 0.2685)
+(-0.0030 0.0465 0.2685)
+(0.0000 0.0465 0.2685)
+(0.0030 0.0465 0.2685)
+(0.0060 0.0465 0.2685)
+(-0.0060 0.0495 0.2685)
+(-0.0030 0.0495 0.2685)
+(0.0000 0.0495 0.2685)
+(0.0030 0.0495 0.2685)
+(0.0060 0.0495 0.2685)
+(-0.0060 0.0525 0.2685)
+(-0.0030 0.0525 0.2685)
+(0.0000 0.0525 0.2685)
+(0.0030 0.0525 0.2685)
+(0.0060 0.0525 0.2685)
+(-0.0060 0.0555 0.2685)
+(-0.0030 0.0555 0.2685)
+(0.0000 0.0555 0.2685)
+(0.0030 0.0555 0.2685)
+(0.0060 0.0555 0.2685)
+(-0.0060 0.0585 0.2685)
+(-0.0030 0.0585 0.2685)
+(0.0000 0.0585 0.2685)
+(0.0030 0.0585 0.2685)
+(0.0060 0.0585 0.2685)
+(-0.0060 0.0615 0.2685)
+(-0.0030 0.0615 0.2685)
+(0.0000 0.0615 0.2685)
+(0.0030 0.0615 0.2685)
+(0.0060 0.0615 0.2685)
+(-0.0060 0.0645 0.2685)
+(-0.0030 0.0645 0.2685)
+(0.0000 0.0645 0.2685)
+(0.0030 0.0645 0.2685)
+(0.0060 0.0645 0.2685)
+(-0.0060 0.0675 0.2685)
+(-0.0030 0.0675 0.2685)
+(0.0000 0.0675 0.2685)
+(0.0030 0.0675 0.2685)
+(0.0060 0.0675 0.2685)
+(-0.0060 0.0705 0.2685)
+(-0.0030 0.0705 0.2685)
+(0.0000 0.0705 0.2685)
+(0.0030 0.0705 0.2685)
+(0.0060 0.0705 0.2685)
+(-0.0060 0.0735 0.2685)
+(-0.0030 0.0735 0.2685)
+(0.0000 0.0735 0.2685)
+(0.0030 0.0735 0.2685)
+(0.0060 0.0735 0.2685)
+(-0.0060 -0.0735 0.2715)
+(-0.0030 -0.0735 0.2715)
+(0.0000 -0.0735 0.2715)
+(0.0030 -0.0735 0.2715)
+(0.0060 -0.0735 0.2715)
+(-0.0060 -0.0705 0.2715)
+(-0.0030 -0.0705 0.2715)
+(0.0000 -0.0705 0.2715)
+(0.0030 -0.0705 0.2715)
+(0.0060 -0.0705 0.2715)
+(-0.0060 -0.0675 0.2715)
+(-0.0030 -0.0675 0.2715)
+(0.0000 -0.0675 0.2715)
+(0.0030 -0.0675 0.2715)
+(0.0060 -0.0675 0.2715)
+(-0.0060 -0.0645 0.2715)
+(-0.0030 -0.0645 0.2715)
+(0.0000 -0.0645 0.2715)
+(0.0030 -0.0645 0.2715)
+(0.0060 -0.0645 0.2715)
+(-0.0060 -0.0615 0.2715)
+(-0.0030 -0.0615 0.2715)
+(0.0000 -0.0615 0.2715)
+(0.0030 -0.0615 0.2715)
+(0.0060 -0.0615 0.2715)
+(-0.0060 -0.0585 0.2715)
+(-0.0030 -0.0585 0.2715)
+(0.0000 -0.0585 0.2715)
+(0.0030 -0.0585 0.2715)
+(0.0060 -0.0585 0.2715)
+(-0.0060 -0.0555 0.2715)
+(-0.0030 -0.0555 0.2715)
+(0.0000 -0.0555 0.2715)
+(0.0030 -0.0555 0.2715)
+(0.0060 -0.0555 0.2715)
+(-0.0060 -0.0525 0.2715)
+(-0.0030 -0.0525 0.2715)
+(0.0000 -0.0525 0.2715)
+(0.0030 -0.0525 0.2715)
+(0.0060 -0.0525 0.2715)
+(-0.0060 -0.0495 0.2715)
+(-0.0030 -0.0495 0.2715)
+(0.0000 -0.0495 0.2715)
+(0.0030 -0.0495 0.2715)
+(0.0060 -0.0495 0.2715)
+(-0.0060 -0.0465 0.2715)
+(-0.0030 -0.0465 0.2715)
+(0.0000 -0.0465 0.2715)
+(0.0030 -0.0465 0.2715)
+(0.0060 -0.0465 0.2715)
+(-0.0060 -0.0435 0.2715)
+(-0.0030 -0.0435 0.2715)
+(0.0000 -0.0435 0.2715)
+(0.0030 -0.0435 0.2715)
+(0.0060 -0.0435 0.2715)
+(-0.0060 -0.0405 0.2715)
+(-0.0030 -0.0405 0.2715)
+(0.0000 -0.0405 0.2715)
+(0.0030 -0.0405 0.2715)
+(0.0060 -0.0405 0.2715)
+(-0.0060 -0.0375 0.2715)
+(-0.0030 -0.0375 0.2715)
+(0.0000 -0.0375 0.2715)
+(0.0030 -0.0375 0.2715)
+(0.0060 -0.0375 0.2715)
+(-0.0060 -0.0345 0.2715)
+(-0.0030 -0.0345 0.2715)
+(0.0000 -0.0345 0.2715)
+(0.0030 -0.0345 0.2715)
+(0.0060 -0.0345 0.2715)
+(-0.0060 -0.0315 0.2715)
+(-0.0030 -0.0315 0.2715)
+(0.0000 -0.0315 0.2715)
+(0.0030 -0.0315 0.2715)
+(0.0060 -0.0315 0.2715)
+(-0.0060 -0.0285 0.2715)
+(-0.0030 -0.0285 0.2715)
+(0.0000 -0.0285 0.2715)
+(0.0030 -0.0285 0.2715)
+(0.0060 -0.0285 0.2715)
+(-0.0060 -0.0255 0.2715)
+(-0.0030 -0.0255 0.2715)
+(0.0000 -0.0255 0.2715)
+(0.0030 -0.0255 0.2715)
+(0.0060 -0.0255 0.2715)
+(-0.0060 -0.0225 0.2715)
+(-0.0030 -0.0225 0.2715)
+(0.0000 -0.0225 0.2715)
+(0.0030 -0.0225 0.2715)
+(0.0060 -0.0225 0.2715)
+(-0.0060 -0.0195 0.2715)
+(-0.0030 -0.0195 0.2715)
+(0.0000 -0.0195 0.2715)
+(0.0030 -0.0195 0.2715)
+(0.0060 -0.0195 0.2715)
+(-0.0060 -0.0165 0.2715)
+(-0.0030 -0.0165 0.2715)
+(0.0000 -0.0165 0.2715)
+(0.0030 -0.0165 0.2715)
+(0.0060 -0.0165 0.2715)
+(-0.0060 -0.0135 0.2715)
+(-0.0030 -0.0135 0.2715)
+(0.0000 -0.0135 0.2715)
+(0.0030 -0.0135 0.2715)
+(0.0060 -0.0135 0.2715)
+(-0.0060 -0.0105 0.2715)
+(-0.0030 -0.0105 0.2715)
+(0.0000 -0.0105 0.2715)
+(0.0030 -0.0105 0.2715)
+(0.0060 -0.0105 0.2715)
+(-0.0060 -0.0075 0.2715)
+(-0.0030 -0.0075 0.2715)
+(0.0000 -0.0075 0.2715)
+(0.0030 -0.0075 0.2715)
+(0.0060 -0.0075 0.2715)
+(-0.0060 -0.0045 0.2715)
+(-0.0030 -0.0045 0.2715)
+(0.0000 -0.0045 0.2715)
+(0.0030 -0.0045 0.2715)
+(0.0060 -0.0045 0.2715)
+(-0.0060 -0.0015 0.2715)
+(-0.0030 -0.0015 0.2715)
+(0.0000 -0.0015 0.2715)
+(0.0030 -0.0015 0.2715)
+(0.0060 -0.0015 0.2715)
+(-0.0060 0.0015 0.2715)
+(-0.0030 0.0015 0.2715)
+(0.0000 0.0015 0.2715)
+(0.0030 0.0015 0.2715)
+(0.0060 0.0015 0.2715)
+(-0.0060 0.0045 0.2715)
+(-0.0030 0.0045 0.2715)
+(0.0000 0.0045 0.2715)
+(0.0030 0.0045 0.2715)
+(0.0060 0.0045 0.2715)
+(-0.0060 0.0075 0.2715)
+(-0.0030 0.0075 0.2715)
+(0.0000 0.0075 0.2715)
+(0.0030 0.0075 0.2715)
+(0.0060 0.0075 0.2715)
+(-0.0060 0.0105 0.2715)
+(-0.0030 0.0105 0.2715)
+(0.0000 0.0105 0.2715)
+(0.0030 0.0105 0.2715)
+(0.0060 0.0105 0.2715)
+(-0.0060 0.0135 0.2715)
+(-0.0030 0.0135 0.2715)
+(0.0000 0.0135 0.2715)
+(0.0030 0.0135 0.2715)
+(0.0060 0.0135 0.2715)
+(-0.0060 0.0165 0.2715)
+(-0.0030 0.0165 0.2715)
+(0.0000 0.0165 0.2715)
+(0.0030 0.0165 0.2715)
+(0.0060 0.0165 0.2715)
+(-0.0060 0.0195 0.2715)
+(-0.0030 0.0195 0.2715)
+(0.0000 0.0195 0.2715)
+(0.0030 0.0195 0.2715)
+(0.0060 0.0195 0.2715)
+(-0.0060 0.0225 0.2715)
+(-0.0030 0.0225 0.2715)
+(0.0000 0.0225 0.2715)
+(0.0030 0.0225 0.2715)
+(0.0060 0.0225 0.2715)
+(-0.0060 0.0255 0.2715)
+(-0.0030 0.0255 0.2715)
+(0.0000 0.0255 0.2715)
+(0.0030 0.0255 0.2715)
+(0.0060 0.0255 0.2715)
+(-0.0060 0.0285 0.2715)
+(-0.0030 0.0285 0.2715)
+(0.0000 0.0285 0.2715)
+(0.0030 0.0285 0.2715)
+(0.0060 0.0285 0.2715)
+(-0.0060 0.0315 0.2715)
+(-0.0030 0.0315 0.2715)
+(0.0000 0.0315 0.2715)
+(0.0030 0.0315 0.2715)
+(0.0060 0.0315 0.2715)
+(-0.0060 0.0345 0.2715)
+(-0.0030 0.0345 0.2715)
+(0.0000 0.0345 0.2715)
+(0.0030 0.0345 0.2715)
+(0.0060 0.0345 0.2715)
+(-0.0060 0.0375 0.2715)
+(-0.0030 0.0375 0.2715)
+(0.0000 0.0375 0.2715)
+(0.0030 0.0375 0.2715)
+(0.0060 0.0375 0.2715)
+(-0.0060 0.0405 0.2715)
+(-0.0030 0.0405 0.2715)
+(0.0000 0.0405 0.2715)
+(0.0030 0.0405 0.2715)
+(0.0060 0.0405 0.2715)
+(-0.0060 0.0435 0.2715)
+(-0.0030 0.0435 0.2715)
+(0.0000 0.0435 0.2715)
+(0.0030 0.0435 0.2715)
+(0.0060 0.0435 0.2715)
+(-0.0060 0.0465 0.2715)
+(-0.0030 0.0465 0.2715)
+(0.0000 0.0465 0.2715)
+(0.0030 0.0465 0.2715)
+(0.0060 0.0465 0.2715)
+(-0.0060 0.0495 0.2715)
+(-0.0030 0.0495 0.2715)
+(0.0000 0.0495 0.2715)
+(0.0030 0.0495 0.2715)
+(0.0060 0.0495 0.2715)
+(-0.0060 0.0525 0.2715)
+(-0.0030 0.0525 0.2715)
+(0.0000 0.0525 0.2715)
+(0.0030 0.0525 0.2715)
+(0.0060 0.0525 0.2715)
+(-0.0060 0.0555 0.2715)
+(-0.0030 0.0555 0.2715)
+(0.0000 0.0555 0.2715)
+(0.0030 0.0555 0.2715)
+(0.0060 0.0555 0.2715)
+(-0.0060 0.0585 0.2715)
+(-0.0030 0.0585 0.2715)
+(0.0000 0.0585 0.2715)
+(0.0030 0.0585 0.2715)
+(0.0060 0.0585 0.2715)
+(-0.0060 0.0615 0.2715)
+(-0.0030 0.0615 0.2715)
+(0.0000 0.0615 0.2715)
+(0.0030 0.0615 0.2715)
+(0.0060 0.0615 0.2715)
+(-0.0060 0.0645 0.2715)
+(-0.0030 0.0645 0.2715)
+(0.0000 0.0645 0.2715)
+(0.0030 0.0645 0.2715)
+(0.0060 0.0645 0.2715)
+(-0.0060 0.0675 0.2715)
+(-0.0030 0.0675 0.2715)
+(0.0000 0.0675 0.2715)
+(0.0030 0.0675 0.2715)
+(0.0060 0.0675 0.2715)
+(-0.0060 0.0705 0.2715)
+(-0.0030 0.0705 0.2715)
+(0.0000 0.0705 0.2715)
+(0.0030 0.0705 0.2715)
+(0.0060 0.0705 0.2715)
+(-0.0060 0.0735 0.2715)
+(-0.0030 0.0735 0.2715)
+(0.0000 0.0735 0.2715)
+(0.0030 0.0735 0.2715)
+(0.0060 0.0735 0.2715)
+(-0.0060 -0.0735 0.2745)
+(-0.0030 -0.0735 0.2745)
+(0.0000 -0.0735 0.2745)
+(0.0030 -0.0735 0.2745)
+(0.0060 -0.0735 0.2745)
+(-0.0060 -0.0705 0.2745)
+(-0.0030 -0.0705 0.2745)
+(0.0000 -0.0705 0.2745)
+(0.0030 -0.0705 0.2745)
+(0.0060 -0.0705 0.2745)
+(-0.0060 -0.0675 0.2745)
+(-0.0030 -0.0675 0.2745)
+(0.0000 -0.0675 0.2745)
+(0.0030 -0.0675 0.2745)
+(0.0060 -0.0675 0.2745)
+(-0.0060 -0.0645 0.2745)
+(-0.0030 -0.0645 0.2745)
+(0.0000 -0.0645 0.2745)
+(0.0030 -0.0645 0.2745)
+(0.0060 -0.0645 0.2745)
+(-0.0060 -0.0615 0.2745)
+(-0.0030 -0.0615 0.2745)
+(0.0000 -0.0615 0.2745)
+(0.0030 -0.0615 0.2745)
+(0.0060 -0.0615 0.2745)
+(-0.0060 -0.0585 0.2745)
+(-0.0030 -0.0585 0.2745)
+(0.0000 -0.0585 0.2745)
+(0.0030 -0.0585 0.2745)
+(0.0060 -0.0585 0.2745)
+(-0.0060 -0.0555 0.2745)
+(-0.0030 -0.0555 0.2745)
+(0.0000 -0.0555 0.2745)
+(0.0030 -0.0555 0.2745)
+(0.0060 -0.0555 0.2745)
+(-0.0060 -0.0525 0.2745)
+(-0.0030 -0.0525 0.2745)
+(0.0000 -0.0525 0.2745)
+(0.0030 -0.0525 0.2745)
+(0.0060 -0.0525 0.2745)
+(-0.0060 -0.0495 0.2745)
+(-0.0030 -0.0495 0.2745)
+(0.0000 -0.0495 0.2745)
+(0.0030 -0.0495 0.2745)
+(0.0060 -0.0495 0.2745)
+(-0.0060 -0.0465 0.2745)
+(-0.0030 -0.0465 0.2745)
+(0.0000 -0.0465 0.2745)
+(0.0030 -0.0465 0.2745)
+(0.0060 -0.0465 0.2745)
+(-0.0060 -0.0435 0.2745)
+(-0.0030 -0.0435 0.2745)
+(0.0000 -0.0435 0.2745)
+(0.0030 -0.0435 0.2745)
+(0.0060 -0.0435 0.2745)
+(-0.0060 -0.0405 0.2745)
+(-0.0030 -0.0405 0.2745)
+(0.0000 -0.0405 0.2745)
+(0.0030 -0.0405 0.2745)
+(0.0060 -0.0405 0.2745)
+(-0.0060 -0.0375 0.2745)
+(-0.0030 -0.0375 0.2745)
+(0.0000 -0.0375 0.2745)
+(0.0030 -0.0375 0.2745)
+(0.0060 -0.0375 0.2745)
+(-0.0060 -0.0345 0.2745)
+(-0.0030 -0.0345 0.2745)
+(0.0000 -0.0345 0.2745)
+(0.0030 -0.0345 0.2745)
+(0.0060 -0.0345 0.2745)
+(-0.0060 -0.0315 0.2745)
+(-0.0030 -0.0315 0.2745)
+(0.0000 -0.0315 0.2745)
+(0.0030 -0.0315 0.2745)
+(0.0060 -0.0315 0.2745)
+(-0.0060 -0.0285 0.2745)
+(-0.0030 -0.0285 0.2745)
+(0.0000 -0.0285 0.2745)
+(0.0030 -0.0285 0.2745)
+(0.0060 -0.0285 0.2745)
+(-0.0060 -0.0255 0.2745)
+(-0.0030 -0.0255 0.2745)
+(0.0000 -0.0255 0.2745)
+(0.0030 -0.0255 0.2745)
+(0.0060 -0.0255 0.2745)
+(-0.0060 -0.0225 0.2745)
+(-0.0030 -0.0225 0.2745)
+(0.0000 -0.0225 0.2745)
+(0.0030 -0.0225 0.2745)
+(0.0060 -0.0225 0.2745)
+(-0.0060 -0.0195 0.2745)
+(-0.0030 -0.0195 0.2745)
+(0.0000 -0.0195 0.2745)
+(0.0030 -0.0195 0.2745)
+(0.0060 -0.0195 0.2745)
+(-0.0060 -0.0165 0.2745)
+(-0.0030 -0.0165 0.2745)
+(0.0000 -0.0165 0.2745)
+(0.0030 -0.0165 0.2745)
+(0.0060 -0.0165 0.2745)
+(-0.0060 -0.0135 0.2745)
+(-0.0030 -0.0135 0.2745)
+(0.0000 -0.0135 0.2745)
+(0.0030 -0.0135 0.2745)
+(0.0060 -0.0135 0.2745)
+(-0.0060 -0.0105 0.2745)
+(-0.0030 -0.0105 0.2745)
+(0.0000 -0.0105 0.2745)
+(0.0030 -0.0105 0.2745)
+(0.0060 -0.0105 0.2745)
+(-0.0060 -0.0075 0.2745)
+(-0.0030 -0.0075 0.2745)
+(0.0000 -0.0075 0.2745)
+(0.0030 -0.0075 0.2745)
+(0.0060 -0.0075 0.2745)
+(-0.0060 -0.0045 0.2745)
+(-0.0030 -0.0045 0.2745)
+(0.0000 -0.0045 0.2745)
+(0.0030 -0.0045 0.2745)
+(0.0060 -0.0045 0.2745)
+(-0.0060 -0.0015 0.2745)
+(-0.0030 -0.0015 0.2745)
+(0.0000 -0.0015 0.2745)
+(0.0030 -0.0015 0.2745)
+(0.0060 -0.0015 0.2745)
+(-0.0060 0.0015 0.2745)
+(-0.0030 0.0015 0.2745)
+(0.0000 0.0015 0.2745)
+(0.0030 0.0015 0.2745)
+(0.0060 0.0015 0.2745)
+(-0.0060 0.0045 0.2745)
+(-0.0030 0.0045 0.2745)
+(0.0000 0.0045 0.2745)
+(0.0030 0.0045 0.2745)
+(0.0060 0.0045 0.2745)
+(-0.0060 0.0075 0.2745)
+(-0.0030 0.0075 0.2745)
+(0.0000 0.0075 0.2745)
+(0.0030 0.0075 0.2745)
+(0.0060 0.0075 0.2745)
+(-0.0060 0.0105 0.2745)
+(-0.0030 0.0105 0.2745)
+(0.0000 0.0105 0.2745)
+(0.0030 0.0105 0.2745)
+(0.0060 0.0105 0.2745)
+(-0.0060 0.0135 0.2745)
+(-0.0030 0.0135 0.2745)
+(0.0000 0.0135 0.2745)
+(0.0030 0.0135 0.2745)
+(0.0060 0.0135 0.2745)
+(-0.0060 0.0165 0.2745)
+(-0.0030 0.0165 0.2745)
+(0.0000 0.0165 0.2745)
+(0.0030 0.0165 0.2745)
+(0.0060 0.0165 0.2745)
+(-0.0060 0.0195 0.2745)
+(-0.0030 0.0195 0.2745)
+(0.0000 0.0195 0.2745)
+(0.0030 0.0195 0.2745)
+(0.0060 0.0195 0.2745)
+(-0.0060 0.0225 0.2745)
+(-0.0030 0.0225 0.2745)
+(0.0000 0.0225 0.2745)
+(0.0030 0.0225 0.2745)
+(0.0060 0.0225 0.2745)
+(-0.0060 0.0255 0.2745)
+(-0.0030 0.0255 0.2745)
+(0.0000 0.0255 0.2745)
+(0.0030 0.0255 0.2745)
+(0.0060 0.0255 0.2745)
+(-0.0060 0.0285 0.2745)
+(-0.0030 0.0285 0.2745)
+(0.0000 0.0285 0.2745)
+(0.0030 0.0285 0.2745)
+(0.0060 0.0285 0.2745)
+(-0.0060 0.0315 0.2745)
+(-0.0030 0.0315 0.2745)
+(0.0000 0.0315 0.2745)
+(0.0030 0.0315 0.2745)
+(0.0060 0.0315 0.2745)
+(-0.0060 0.0345 0.2745)
+(-0.0030 0.0345 0.2745)
+(0.0000 0.0345 0.2745)
+(0.0030 0.0345 0.2745)
+(0.0060 0.0345 0.2745)
+(-0.0060 0.0375 0.2745)
+(-0.0030 0.0375 0.2745)
+(0.0000 0.0375 0.2745)
+(0.0030 0.0375 0.2745)
+(0.0060 0.0375 0.2745)
+(-0.0060 0.0405 0.2745)
+(-0.0030 0.0405 0.2745)
+(0.0000 0.0405 0.2745)
+(0.0030 0.0405 0.2745)
+(0.0060 0.0405 0.2745)
+(-0.0060 0.0435 0.2745)
+(-0.0030 0.0435 0.2745)
+(0.0000 0.0435 0.2745)
+(0.0030 0.0435 0.2745)
+(0.0060 0.0435 0.2745)
+(-0.0060 0.0465 0.2745)
+(-0.0030 0.0465 0.2745)
+(0.0000 0.0465 0.2745)
+(0.0030 0.0465 0.2745)
+(0.0060 0.0465 0.2745)
+(-0.0060 0.0495 0.2745)
+(-0.0030 0.0495 0.2745)
+(0.0000 0.0495 0.2745)
+(0.0030 0.0495 0.2745)
+(0.0060 0.0495 0.2745)
+(-0.0060 0.0525 0.2745)
+(-0.0030 0.0525 0.2745)
+(0.0000 0.0525 0.2745)
+(0.0030 0.0525 0.2745)
+(0.0060 0.0525 0.2745)
+(-0.0060 0.0555 0.2745)
+(-0.0030 0.0555 0.2745)
+(0.0000 0.0555 0.2745)
+(0.0030 0.0555 0.2745)
+(0.0060 0.0555 0.2745)
+(-0.0060 0.0585 0.2745)
+(-0.0030 0.0585 0.2745)
+(0.0000 0.0585 0.2745)
+(0.0030 0.0585 0.2745)
+(0.0060 0.0585 0.2745)
+(-0.0060 0.0615 0.2745)
+(-0.0030 0.0615 0.2745)
+(0.0000 0.0615 0.2745)
+(0.0030 0.0615 0.2745)
+(0.0060 0.0615 0.2745)
+(-0.0060 0.0645 0.2745)
+(-0.0030 0.0645 0.2745)
+(0.0000 0.0645 0.2745)
+(0.0030 0.0645 0.2745)
+(0.0060 0.0645 0.2745)
+(-0.0060 0.0675 0.2745)
+(-0.0030 0.0675 0.2745)
+(0.0000 0.0675 0.2745)
+(0.0030 0.0675 0.2745)
+(0.0060 0.0675 0.2745)
+(-0.0060 0.0705 0.2745)
+(-0.0030 0.0705 0.2745)
+(0.0000 0.0705 0.2745)
+(0.0030 0.0705 0.2745)
+(0.0060 0.0705 0.2745)
+(-0.0060 0.0735 0.2745)
+(-0.0030 0.0735 0.2745)
+(0.0000 0.0735 0.2745)
+(0.0030 0.0735 0.2745)
+(0.0060 0.0735 0.2745)
+(-0.0060 -0.0735 0.2775)
+(-0.0030 -0.0735 0.2775)
+(0.0000 -0.0735 0.2775)
+(0.0030 -0.0735 0.2775)
+(0.0060 -0.0735 0.2775)
+(-0.0060 -0.0705 0.2775)
+(-0.0030 -0.0705 0.2775)
+(0.0000 -0.0705 0.2775)
+(0.0030 -0.0705 0.2775)
+(0.0060 -0.0705 0.2775)
+(-0.0060 -0.0675 0.2775)
+(-0.0030 -0.0675 0.2775)
+(0.0000 -0.0675 0.2775)
+(0.0030 -0.0675 0.2775)
+(0.0060 -0.0675 0.2775)
+(-0.0060 -0.0645 0.2775)
+(-0.0030 -0.0645 0.2775)
+(0.0000 -0.0645 0.2775)
+(0.0030 -0.0645 0.2775)
+(0.0060 -0.0645 0.2775)
+(-0.0060 -0.0615 0.2775)
+(-0.0030 -0.0615 0.2775)
+(0.0000 -0.0615 0.2775)
+(0.0030 -0.0615 0.2775)
+(0.0060 -0.0615 0.2775)
+(-0.0060 -0.0585 0.2775)
+(-0.0030 -0.0585 0.2775)
+(0.0000 -0.0585 0.2775)
+(0.0030 -0.0585 0.2775)
+(0.0060 -0.0585 0.2775)
+(-0.0060 -0.0555 0.2775)
+(-0.0030 -0.0555 0.2775)
+(0.0000 -0.0555 0.2775)
+(0.0030 -0.0555 0.2775)
+(0.0060 -0.0555 0.2775)
+(-0.0060 -0.0525 0.2775)
+(-0.0030 -0.0525 0.2775)
+(0.0000 -0.0525 0.2775)
+(0.0030 -0.0525 0.2775)
+(0.0060 -0.0525 0.2775)
+(-0.0060 -0.0495 0.2775)
+(-0.0030 -0.0495 0.2775)
+(0.0000 -0.0495 0.2775)
+(0.0030 -0.0495 0.2775)
+(0.0060 -0.0495 0.2775)
+(-0.0060 -0.0465 0.2775)
+(-0.0030 -0.0465 0.2775)
+(0.0000 -0.0465 0.2775)
+(0.0030 -0.0465 0.2775)
+(0.0060 -0.0465 0.2775)
+(-0.0060 -0.0435 0.2775)
+(-0.0030 -0.0435 0.2775)
+(0.0000 -0.0435 0.2775)
+(0.0030 -0.0435 0.2775)
+(0.0060 -0.0435 0.2775)
+(-0.0060 -0.0405 0.2775)
+(-0.0030 -0.0405 0.2775)
+(0.0000 -0.0405 0.2775)
+(0.0030 -0.0405 0.2775)
+(0.0060 -0.0405 0.2775)
+(-0.0060 -0.0375 0.2775)
+(-0.0030 -0.0375 0.2775)
+(0.0000 -0.0375 0.2775)
+(0.0030 -0.0375 0.2775)
+(0.0060 -0.0375 0.2775)
+(-0.0060 -0.0345 0.2775)
+(-0.0030 -0.0345 0.2775)
+(0.0000 -0.0345 0.2775)
+(0.0030 -0.0345 0.2775)
+(0.0060 -0.0345 0.2775)
+(-0.0060 -0.0315 0.2775)
+(-0.0030 -0.0315 0.2775)
+(0.0000 -0.0315 0.2775)
+(0.0030 -0.0315 0.2775)
+(0.0060 -0.0315 0.2775)
+(-0.0060 -0.0285 0.2775)
+(-0.0030 -0.0285 0.2775)
+(0.0000 -0.0285 0.2775)
+(0.0030 -0.0285 0.2775)
+(0.0060 -0.0285 0.2775)
+(-0.0060 -0.0255 0.2775)
+(-0.0030 -0.0255 0.2775)
+(0.0000 -0.0255 0.2775)
+(0.0030 -0.0255 0.2775)
+(0.0060 -0.0255 0.2775)
+(-0.0060 -0.0225 0.2775)
+(-0.0030 -0.0225 0.2775)
+(0.0000 -0.0225 0.2775)
+(0.0030 -0.0225 0.2775)
+(0.0060 -0.0225 0.2775)
+(-0.0060 -0.0195 0.2775)
+(-0.0030 -0.0195 0.2775)
+(0.0000 -0.0195 0.2775)
+(0.0030 -0.0195 0.2775)
+(0.0060 -0.0195 0.2775)
+(-0.0060 -0.0165 0.2775)
+(-0.0030 -0.0165 0.2775)
+(0.0000 -0.0165 0.2775)
+(0.0030 -0.0165 0.2775)
+(0.0060 -0.0165 0.2775)
+(-0.0060 -0.0135 0.2775)
+(-0.0030 -0.0135 0.2775)
+(0.0000 -0.0135 0.2775)
+(0.0030 -0.0135 0.2775)
+(0.0060 -0.0135 0.2775)
+(-0.0060 -0.0105 0.2775)
+(-0.0030 -0.0105 0.2775)
+(0.0000 -0.0105 0.2775)
+(0.0030 -0.0105 0.2775)
+(0.0060 -0.0105 0.2775)
+(-0.0060 -0.0075 0.2775)
+(-0.0030 -0.0075 0.2775)
+(0.0000 -0.0075 0.2775)
+(0.0030 -0.0075 0.2775)
+(0.0060 -0.0075 0.2775)
+(-0.0060 -0.0045 0.2775)
+(-0.0030 -0.0045 0.2775)
+(0.0000 -0.0045 0.2775)
+(0.0030 -0.0045 0.2775)
+(0.0060 -0.0045 0.2775)
+(-0.0060 -0.0015 0.2775)
+(-0.0030 -0.0015 0.2775)
+(0.0000 -0.0015 0.2775)
+(0.0030 -0.0015 0.2775)
+(0.0060 -0.0015 0.2775)
+(-0.0060 0.0015 0.2775)
+(-0.0030 0.0015 0.2775)
+(0.0000 0.0015 0.2775)
+(0.0030 0.0015 0.2775)
+(0.0060 0.0015 0.2775)
+(-0.0060 0.0045 0.2775)
+(-0.0030 0.0045 0.2775)
+(0.0000 0.0045 0.2775)
+(0.0030 0.0045 0.2775)
+(0.0060 0.0045 0.2775)
+(-0.0060 0.0075 0.2775)
+(-0.0030 0.0075 0.2775)
+(0.0000 0.0075 0.2775)
+(0.0030 0.0075 0.2775)
+(0.0060 0.0075 0.2775)
+(-0.0060 0.0105 0.2775)
+(-0.0030 0.0105 0.2775)
+(0.0000 0.0105 0.2775)
+(0.0030 0.0105 0.2775)
+(0.0060 0.0105 0.2775)
+(-0.0060 0.0135 0.2775)
+(-0.0030 0.0135 0.2775)
+(0.0000 0.0135 0.2775)
+(0.0030 0.0135 0.2775)
+(0.0060 0.0135 0.2775)
+(-0.0060 0.0165 0.2775)
+(-0.0030 0.0165 0.2775)
+(0.0000 0.0165 0.2775)
+(0.0030 0.0165 0.2775)
+(0.0060 0.0165 0.2775)
+(-0.0060 0.0195 0.2775)
+(-0.0030 0.0195 0.2775)
+(0.0000 0.0195 0.2775)
+(0.0030 0.0195 0.2775)
+(0.0060 0.0195 0.2775)
+(-0.0060 0.0225 0.2775)
+(-0.0030 0.0225 0.2775)
+(0.0000 0.0225 0.2775)
+(0.0030 0.0225 0.2775)
+(0.0060 0.0225 0.2775)
+(-0.0060 0.0255 0.2775)
+(-0.0030 0.0255 0.2775)
+(0.0000 0.0255 0.2775)
+(0.0030 0.0255 0.2775)
+(0.0060 0.0255 0.2775)
+(-0.0060 0.0285 0.2775)
+(-0.0030 0.0285 0.2775)
+(0.0000 0.0285 0.2775)
+(0.0030 0.0285 0.2775)
+(0.0060 0.0285 0.2775)
+(-0.0060 0.0315 0.2775)
+(-0.0030 0.0315 0.2775)
+(0.0000 0.0315 0.2775)
+(0.0030 0.0315 0.2775)
+(0.0060 0.0315 0.2775)
+(-0.0060 0.0345 0.2775)
+(-0.0030 0.0345 0.2775)
+(0.0000 0.0345 0.2775)
+(0.0030 0.0345 0.2775)
+(0.0060 0.0345 0.2775)
+(-0.0060 0.0375 0.2775)
+(-0.0030 0.0375 0.2775)
+(0.0000 0.0375 0.2775)
+(0.0030 0.0375 0.2775)
+(0.0060 0.0375 0.2775)
+(-0.0060 0.0405 0.2775)
+(-0.0030 0.0405 0.2775)
+(0.0000 0.0405 0.2775)
+(0.0030 0.0405 0.2775)
+(0.0060 0.0405 0.2775)
+(-0.0060 0.0435 0.2775)
+(-0.0030 0.0435 0.2775)
+(0.0000 0.0435 0.2775)
+(0.0030 0.0435 0.2775)
+(0.0060 0.0435 0.2775)
+(-0.0060 0.0465 0.2775)
+(-0.0030 0.0465 0.2775)
+(0.0000 0.0465 0.2775)
+(0.0030 0.0465 0.2775)
+(0.0060 0.0465 0.2775)
+(-0.0060 0.0495 0.2775)
+(-0.0030 0.0495 0.2775)
+(0.0000 0.0495 0.2775)
+(0.0030 0.0495 0.2775)
+(0.0060 0.0495 0.2775)
+(-0.0060 0.0525 0.2775)
+(-0.0030 0.0525 0.2775)
+(0.0000 0.0525 0.2775)
+(0.0030 0.0525 0.2775)
+(0.0060 0.0525 0.2775)
+(-0.0060 0.0555 0.2775)
+(-0.0030 0.0555 0.2775)
+(0.0000 0.0555 0.2775)
+(0.0030 0.0555 0.2775)
+(0.0060 0.0555 0.2775)
+(-0.0060 0.0585 0.2775)
+(-0.0030 0.0585 0.2775)
+(0.0000 0.0585 0.2775)
+(0.0030 0.0585 0.2775)
+(0.0060 0.0585 0.2775)
+(-0.0060 0.0615 0.2775)
+(-0.0030 0.0615 0.2775)
+(0.0000 0.0615 0.2775)
+(0.0030 0.0615 0.2775)
+(0.0060 0.0615 0.2775)
+(-0.0060 0.0645 0.2775)
+(-0.0030 0.0645 0.2775)
+(0.0000 0.0645 0.2775)
+(0.0030 0.0645 0.2775)
+(0.0060 0.0645 0.2775)
+(-0.0060 0.0675 0.2775)
+(-0.0030 0.0675 0.2775)
+(0.0000 0.0675 0.2775)
+(0.0030 0.0675 0.2775)
+(0.0060 0.0675 0.2775)
+(-0.0060 0.0705 0.2775)
+(-0.0030 0.0705 0.2775)
+(0.0000 0.0705 0.2775)
+(0.0030 0.0705 0.2775)
+(0.0060 0.0705 0.2775)
+(-0.0060 0.0735 0.2775)
+(-0.0030 0.0735 0.2775)
+(0.0000 0.0735 0.2775)
+(0.0030 0.0735 0.2775)
+(0.0060 0.0735 0.2775)
+(-0.0060 -0.0735 0.2805)
+(-0.0030 -0.0735 0.2805)
+(0.0000 -0.0735 0.2805)
+(0.0030 -0.0735 0.2805)
+(0.0060 -0.0735 0.2805)
+(-0.0060 -0.0705 0.2805)
+(-0.0030 -0.0705 0.2805)
+(0.0000 -0.0705 0.2805)
+(0.0030 -0.0705 0.2805)
+(0.0060 -0.0705 0.2805)
+(-0.0060 -0.0675 0.2805)
+(-0.0030 -0.0675 0.2805)
+(0.0000 -0.0675 0.2805)
+(0.0030 -0.0675 0.2805)
+(0.0060 -0.0675 0.2805)
+(-0.0060 -0.0645 0.2805)
+(-0.0030 -0.0645 0.2805)
+(0.0000 -0.0645 0.2805)
+(0.0030 -0.0645 0.2805)
+(0.0060 -0.0645 0.2805)
+(-0.0060 -0.0615 0.2805)
+(-0.0030 -0.0615 0.2805)
+(0.0000 -0.0615 0.2805)
+(0.0030 -0.0615 0.2805)
+(0.0060 -0.0615 0.2805)
+(-0.0060 -0.0585 0.2805)
+(-0.0030 -0.0585 0.2805)
+(0.0000 -0.0585 0.2805)
+(0.0030 -0.0585 0.2805)
+(0.0060 -0.0585 0.2805)
+(-0.0060 -0.0555 0.2805)
+(-0.0030 -0.0555 0.2805)
+(0.0000 -0.0555 0.2805)
+(0.0030 -0.0555 0.2805)
+(0.0060 -0.0555 0.2805)
+(-0.0060 -0.0525 0.2805)
+(-0.0030 -0.0525 0.2805)
+(0.0000 -0.0525 0.2805)
+(0.0030 -0.0525 0.2805)
+(0.0060 -0.0525 0.2805)
+(-0.0060 -0.0495 0.2805)
+(-0.0030 -0.0495 0.2805)
+(0.0000 -0.0495 0.2805)
+(0.0030 -0.0495 0.2805)
+(0.0060 -0.0495 0.2805)
+(-0.0060 -0.0465 0.2805)
+(-0.0030 -0.0465 0.2805)
+(0.0000 -0.0465 0.2805)
+(0.0030 -0.0465 0.2805)
+(0.0060 -0.0465 0.2805)
+(-0.0060 -0.0435 0.2805)
+(-0.0030 -0.0435 0.2805)
+(0.0000 -0.0435 0.2805)
+(0.0030 -0.0435 0.2805)
+(0.0060 -0.0435 0.2805)
+(-0.0060 -0.0405 0.2805)
+(-0.0030 -0.0405 0.2805)
+(0.0000 -0.0405 0.2805)
+(0.0030 -0.0405 0.2805)
+(0.0060 -0.0405 0.2805)
+(-0.0060 -0.0375 0.2805)
+(-0.0030 -0.0375 0.2805)
+(0.0000 -0.0375 0.2805)
+(0.0030 -0.0375 0.2805)
+(0.0060 -0.0375 0.2805)
+(-0.0060 -0.0345 0.2805)
+(-0.0030 -0.0345 0.2805)
+(0.0000 -0.0345 0.2805)
+(0.0030 -0.0345 0.2805)
+(0.0060 -0.0345 0.2805)
+(-0.0060 -0.0315 0.2805)
+(-0.0030 -0.0315 0.2805)
+(0.0000 -0.0315 0.2805)
+(0.0030 -0.0315 0.2805)
+(0.0060 -0.0315 0.2805)
+(-0.0060 -0.0285 0.2805)
+(-0.0030 -0.0285 0.2805)
+(0.0000 -0.0285 0.2805)
+(0.0030 -0.0285 0.2805)
+(0.0060 -0.0285 0.2805)
+(-0.0060 -0.0255 0.2805)
+(-0.0030 -0.0255 0.2805)
+(0.0000 -0.0255 0.2805)
+(0.0030 -0.0255 0.2805)
+(0.0060 -0.0255 0.2805)
+(-0.0060 -0.0225 0.2805)
+(-0.0030 -0.0225 0.2805)
+(0.0000 -0.0225 0.2805)
+(0.0030 -0.0225 0.2805)
+(0.0060 -0.0225 0.2805)
+(-0.0060 -0.0195 0.2805)
+(-0.0030 -0.0195 0.2805)
+(0.0000 -0.0195 0.2805)
+(0.0030 -0.0195 0.2805)
+(0.0060 -0.0195 0.2805)
+(-0.0060 -0.0165 0.2805)
+(-0.0030 -0.0165 0.2805)
+(0.0000 -0.0165 0.2805)
+(0.0030 -0.0165 0.2805)
+(0.0060 -0.0165 0.2805)
+(-0.0060 -0.0135 0.2805)
+(-0.0030 -0.0135 0.2805)
+(0.0000 -0.0135 0.2805)
+(0.0030 -0.0135 0.2805)
+(0.0060 -0.0135 0.2805)
+(-0.0060 -0.0105 0.2805)
+(-0.0030 -0.0105 0.2805)
+(0.0000 -0.0105 0.2805)
+(0.0030 -0.0105 0.2805)
+(0.0060 -0.0105 0.2805)
+(-0.0060 -0.0075 0.2805)
+(-0.0030 -0.0075 0.2805)
+(0.0000 -0.0075 0.2805)
+(0.0030 -0.0075 0.2805)
+(0.0060 -0.0075 0.2805)
+(-0.0060 -0.0045 0.2805)
+(-0.0030 -0.0045 0.2805)
+(0.0000 -0.0045 0.2805)
+(0.0030 -0.0045 0.2805)
+(0.0060 -0.0045 0.2805)
+(-0.0060 -0.0015 0.2805)
+(-0.0030 -0.0015 0.2805)
+(0.0000 -0.0015 0.2805)
+(0.0030 -0.0015 0.2805)
+(0.0060 -0.0015 0.2805)
+(-0.0060 0.0015 0.2805)
+(-0.0030 0.0015 0.2805)
+(0.0000 0.0015 0.2805)
+(0.0030 0.0015 0.2805)
+(0.0060 0.0015 0.2805)
+(-0.0060 0.0045 0.2805)
+(-0.0030 0.0045 0.2805)
+(0.0000 0.0045 0.2805)
+(0.0030 0.0045 0.2805)
+(0.0060 0.0045 0.2805)
+(-0.0060 0.0075 0.2805)
+(-0.0030 0.0075 0.2805)
+(0.0000 0.0075 0.2805)
+(0.0030 0.0075 0.2805)
+(0.0060 0.0075 0.2805)
+(-0.0060 0.0105 0.2805)
+(-0.0030 0.0105 0.2805)
+(0.0000 0.0105 0.2805)
+(0.0030 0.0105 0.2805)
+(0.0060 0.0105 0.2805)
+(-0.0060 0.0135 0.2805)
+(-0.0030 0.0135 0.2805)
+(0.0000 0.0135 0.2805)
+(0.0030 0.0135 0.2805)
+(0.0060 0.0135 0.2805)
+(-0.0060 0.0165 0.2805)
+(-0.0030 0.0165 0.2805)
+(0.0000 0.0165 0.2805)
+(0.0030 0.0165 0.2805)
+(0.0060 0.0165 0.2805)
+(-0.0060 0.0195 0.2805)
+(-0.0030 0.0195 0.2805)
+(0.0000 0.0195 0.2805)
+(0.0030 0.0195 0.2805)
+(0.0060 0.0195 0.2805)
+(-0.0060 0.0225 0.2805)
+(-0.0030 0.0225 0.2805)
+(0.0000 0.0225 0.2805)
+(0.0030 0.0225 0.2805)
+(0.0060 0.0225 0.2805)
+(-0.0060 0.0255 0.2805)
+(-0.0030 0.0255 0.2805)
+(0.0000 0.0255 0.2805)
+(0.0030 0.0255 0.2805)
+(0.0060 0.0255 0.2805)
+(-0.0060 0.0285 0.2805)
+(-0.0030 0.0285 0.2805)
+(0.0000 0.0285 0.2805)
+(0.0030 0.0285 0.2805)
+(0.0060 0.0285 0.2805)
+(-0.0060 0.0315 0.2805)
+(-0.0030 0.0315 0.2805)
+(0.0000 0.0315 0.2805)
+(0.0030 0.0315 0.2805)
+(0.0060 0.0315 0.2805)
+(-0.0060 0.0345 0.2805)
+(-0.0030 0.0345 0.2805)
+(0.0000 0.0345 0.2805)
+(0.0030 0.0345 0.2805)
+(0.0060 0.0345 0.2805)
+(-0.0060 0.0375 0.2805)
+(-0.0030 0.0375 0.2805)
+(0.0000 0.0375 0.2805)
+(0.0030 0.0375 0.2805)
+(0.0060 0.0375 0.2805)
+(-0.0060 0.0405 0.2805)
+(-0.0030 0.0405 0.2805)
+(0.0000 0.0405 0.2805)
+(0.0030 0.0405 0.2805)
+(0.0060 0.0405 0.2805)
+(-0.0060 0.0435 0.2805)
+(-0.0030 0.0435 0.2805)
+(0.0000 0.0435 0.2805)
+(0.0030 0.0435 0.2805)
+(0.0060 0.0435 0.2805)
+(-0.0060 0.0465 0.2805)
+(-0.0030 0.0465 0.2805)
+(0.0000 0.0465 0.2805)
+(0.0030 0.0465 0.2805)
+(0.0060 0.0465 0.2805)
+(-0.0060 0.0495 0.2805)
+(-0.0030 0.0495 0.2805)
+(0.0000 0.0495 0.2805)
+(0.0030 0.0495 0.2805)
+(0.0060 0.0495 0.2805)
+(-0.0060 0.0525 0.2805)
+(-0.0030 0.0525 0.2805)
+(0.0000 0.0525 0.2805)
+(0.0030 0.0525 0.2805)
+(0.0060 0.0525 0.2805)
+(-0.0060 0.0555 0.2805)
+(-0.0030 0.0555 0.2805)
+(0.0000 0.0555 0.2805)
+(0.0030 0.0555 0.2805)
+(0.0060 0.0555 0.2805)
+(-0.0060 0.0585 0.2805)
+(-0.0030 0.0585 0.2805)
+(0.0000 0.0585 0.2805)
+(0.0030 0.0585 0.2805)
+(0.0060 0.0585 0.2805)
+(-0.0060 0.0615 0.2805)
+(-0.0030 0.0615 0.2805)
+(0.0000 0.0615 0.2805)
+(0.0030 0.0615 0.2805)
+(0.0060 0.0615 0.2805)
+(-0.0060 0.0645 0.2805)
+(-0.0030 0.0645 0.2805)
+(0.0000 0.0645 0.2805)
+(0.0030 0.0645 0.2805)
+(0.0060 0.0645 0.2805)
+(-0.0060 0.0675 0.2805)
+(-0.0030 0.0675 0.2805)
+(0.0000 0.0675 0.2805)
+(0.0030 0.0675 0.2805)
+(0.0060 0.0675 0.2805)
+(-0.0060 0.0705 0.2805)
+(-0.0030 0.0705 0.2805)
+(0.0000 0.0705 0.2805)
+(0.0030 0.0705 0.2805)
+(0.0060 0.0705 0.2805)
+(-0.0060 0.0735 0.2805)
+(-0.0030 0.0735 0.2805)
+(0.0000 0.0735 0.2805)
+(0.0030 0.0735 0.2805)
+(0.0060 0.0735 0.2805)
+(-0.0060 -0.0735 0.2835)
+(-0.0030 -0.0735 0.2835)
+(0.0000 -0.0735 0.2835)
+(0.0030 -0.0735 0.2835)
+(0.0060 -0.0735 0.2835)
+(-0.0060 -0.0705 0.2835)
+(-0.0030 -0.0705 0.2835)
+(0.0000 -0.0705 0.2835)
+(0.0030 -0.0705 0.2835)
+(0.0060 -0.0705 0.2835)
+(-0.0060 -0.0675 0.2835)
+(-0.0030 -0.0675 0.2835)
+(0.0000 -0.0675 0.2835)
+(0.0030 -0.0675 0.2835)
+(0.0060 -0.0675 0.2835)
+(-0.0060 -0.0645 0.2835)
+(-0.0030 -0.0645 0.2835)
+(0.0000 -0.0645 0.2835)
+(0.0030 -0.0645 0.2835)
+(0.0060 -0.0645 0.2835)
+(-0.0060 -0.0615 0.2835)
+(-0.0030 -0.0615 0.2835)
+(0.0000 -0.0615 0.2835)
+(0.0030 -0.0615 0.2835)
+(0.0060 -0.0615 0.2835)
+(-0.0060 -0.0585 0.2835)
+(-0.0030 -0.0585 0.2835)
+(0.0000 -0.0585 0.2835)
+(0.0030 -0.0585 0.2835)
+(0.0060 -0.0585 0.2835)
+(-0.0060 -0.0555 0.2835)
+(-0.0030 -0.0555 0.2835)
+(0.0000 -0.0555 0.2835)
+(0.0030 -0.0555 0.2835)
+(0.0060 -0.0555 0.2835)
+(-0.0060 -0.0525 0.2835)
+(-0.0030 -0.0525 0.2835)
+(0.0000 -0.0525 0.2835)
+(0.0030 -0.0525 0.2835)
+(0.0060 -0.0525 0.2835)
+(-0.0060 -0.0495 0.2835)
+(-0.0030 -0.0495 0.2835)
+(0.0000 -0.0495 0.2835)
+(0.0030 -0.0495 0.2835)
+(0.0060 -0.0495 0.2835)
+(-0.0060 -0.0465 0.2835)
+(-0.0030 -0.0465 0.2835)
+(0.0000 -0.0465 0.2835)
+(0.0030 -0.0465 0.2835)
+(0.0060 -0.0465 0.2835)
+(-0.0060 -0.0435 0.2835)
+(-0.0030 -0.0435 0.2835)
+(0.0000 -0.0435 0.2835)
+(0.0030 -0.0435 0.2835)
+(0.0060 -0.0435 0.2835)
+(-0.0060 -0.0405 0.2835)
+(-0.0030 -0.0405 0.2835)
+(0.0000 -0.0405 0.2835)
+(0.0030 -0.0405 0.2835)
+(0.0060 -0.0405 0.2835)
+(-0.0060 -0.0375 0.2835)
+(-0.0030 -0.0375 0.2835)
+(0.0000 -0.0375 0.2835)
+(0.0030 -0.0375 0.2835)
+(0.0060 -0.0375 0.2835)
+(-0.0060 -0.0345 0.2835)
+(-0.0030 -0.0345 0.2835)
+(0.0000 -0.0345 0.2835)
+(0.0030 -0.0345 0.2835)
+(0.0060 -0.0345 0.2835)
+(-0.0060 -0.0315 0.2835)
+(-0.0030 -0.0315 0.2835)
+(0.0000 -0.0315 0.2835)
+(0.0030 -0.0315 0.2835)
+(0.0060 -0.0315 0.2835)
+(-0.0060 -0.0285 0.2835)
+(-0.0030 -0.0285 0.2835)
+(0.0000 -0.0285 0.2835)
+(0.0030 -0.0285 0.2835)
+(0.0060 -0.0285 0.2835)
+(-0.0060 -0.0255 0.2835)
+(-0.0030 -0.0255 0.2835)
+(0.0000 -0.0255 0.2835)
+(0.0030 -0.0255 0.2835)
+(0.0060 -0.0255 0.2835)
+(-0.0060 -0.0225 0.2835)
+(-0.0030 -0.0225 0.2835)
+(0.0000 -0.0225 0.2835)
+(0.0030 -0.0225 0.2835)
+(0.0060 -0.0225 0.2835)
+(-0.0060 -0.0195 0.2835)
+(-0.0030 -0.0195 0.2835)
+(0.0000 -0.0195 0.2835)
+(0.0030 -0.0195 0.2835)
+(0.0060 -0.0195 0.2835)
+(-0.0060 -0.0165 0.2835)
+(-0.0030 -0.0165 0.2835)
+(0.0000 -0.0165 0.2835)
+(0.0030 -0.0165 0.2835)
+(0.0060 -0.0165 0.2835)
+(-0.0060 -0.0135 0.2835)
+(-0.0030 -0.0135 0.2835)
+(0.0000 -0.0135 0.2835)
+(0.0030 -0.0135 0.2835)
+(0.0060 -0.0135 0.2835)
+(-0.0060 -0.0105 0.2835)
+(-0.0030 -0.0105 0.2835)
+(0.0000 -0.0105 0.2835)
+(0.0030 -0.0105 0.2835)
+(0.0060 -0.0105 0.2835)
+(-0.0060 -0.0075 0.2835)
+(-0.0030 -0.0075 0.2835)
+(0.0000 -0.0075 0.2835)
+(0.0030 -0.0075 0.2835)
+(0.0060 -0.0075 0.2835)
+(-0.0060 -0.0045 0.2835)
+(-0.0030 -0.0045 0.2835)
+(0.0000 -0.0045 0.2835)
+(0.0030 -0.0045 0.2835)
+(0.0060 -0.0045 0.2835)
+(-0.0060 -0.0015 0.2835)
+(-0.0030 -0.0015 0.2835)
+(0.0000 -0.0015 0.2835)
+(0.0030 -0.0015 0.2835)
+(0.0060 -0.0015 0.2835)
+(-0.0060 0.0015 0.2835)
+(-0.0030 0.0015 0.2835)
+(0.0000 0.0015 0.2835)
+(0.0030 0.0015 0.2835)
+(0.0060 0.0015 0.2835)
+(-0.0060 0.0045 0.2835)
+(-0.0030 0.0045 0.2835)
+(0.0000 0.0045 0.2835)
+(0.0030 0.0045 0.2835)
+(0.0060 0.0045 0.2835)
+(-0.0060 0.0075 0.2835)
+(-0.0030 0.0075 0.2835)
+(0.0000 0.0075 0.2835)
+(0.0030 0.0075 0.2835)
+(0.0060 0.0075 0.2835)
+(-0.0060 0.0105 0.2835)
+(-0.0030 0.0105 0.2835)
+(0.0000 0.0105 0.2835)
+(0.0030 0.0105 0.2835)
+(0.0060 0.0105 0.2835)
+(-0.0060 0.0135 0.2835)
+(-0.0030 0.0135 0.2835)
+(0.0000 0.0135 0.2835)
+(0.0030 0.0135 0.2835)
+(0.0060 0.0135 0.2835)
+(-0.0060 0.0165 0.2835)
+(-0.0030 0.0165 0.2835)
+(0.0000 0.0165 0.2835)
+(0.0030 0.0165 0.2835)
+(0.0060 0.0165 0.2835)
+(-0.0060 0.0195 0.2835)
+(-0.0030 0.0195 0.2835)
+(0.0000 0.0195 0.2835)
+(0.0030 0.0195 0.2835)
+(0.0060 0.0195 0.2835)
+(-0.0060 0.0225 0.2835)
+(-0.0030 0.0225 0.2835)
+(0.0000 0.0225 0.2835)
+(0.0030 0.0225 0.2835)
+(0.0060 0.0225 0.2835)
+(-0.0060 0.0255 0.2835)
+(-0.0030 0.0255 0.2835)
+(0.0000 0.0255 0.2835)
+(0.0030 0.0255 0.2835)
+(0.0060 0.0255 0.2835)
+(-0.0060 0.0285 0.2835)
+(-0.0030 0.0285 0.2835)
+(0.0000 0.0285 0.2835)
+(0.0030 0.0285 0.2835)
+(0.0060 0.0285 0.2835)
+(-0.0060 0.0315 0.2835)
+(-0.0030 0.0315 0.2835)
+(0.0000 0.0315 0.2835)
+(0.0030 0.0315 0.2835)
+(0.0060 0.0315 0.2835)
+(-0.0060 0.0345 0.2835)
+(-0.0030 0.0345 0.2835)
+(0.0000 0.0345 0.2835)
+(0.0030 0.0345 0.2835)
+(0.0060 0.0345 0.2835)
+(-0.0060 0.0375 0.2835)
+(-0.0030 0.0375 0.2835)
+(0.0000 0.0375 0.2835)
+(0.0030 0.0375 0.2835)
+(0.0060 0.0375 0.2835)
+(-0.0060 0.0405 0.2835)
+(-0.0030 0.0405 0.2835)
+(0.0000 0.0405 0.2835)
+(0.0030 0.0405 0.2835)
+(0.0060 0.0405 0.2835)
+(-0.0060 0.0435 0.2835)
+(-0.0030 0.0435 0.2835)
+(0.0000 0.0435 0.2835)
+(0.0030 0.0435 0.2835)
+(0.0060 0.0435 0.2835)
+(-0.0060 0.0465 0.2835)
+(-0.0030 0.0465 0.2835)
+(0.0000 0.0465 0.2835)
+(0.0030 0.0465 0.2835)
+(0.0060 0.0465 0.2835)
+(-0.0060 0.0495 0.2835)
+(-0.0030 0.0495 0.2835)
+(0.0000 0.0495 0.2835)
+(0.0030 0.0495 0.2835)
+(0.0060 0.0495 0.2835)
+(-0.0060 0.0525 0.2835)
+(-0.0030 0.0525 0.2835)
+(0.0000 0.0525 0.2835)
+(0.0030 0.0525 0.2835)
+(0.0060 0.0525 0.2835)
+(-0.0060 0.0555 0.2835)
+(-0.0030 0.0555 0.2835)
+(0.0000 0.0555 0.2835)
+(0.0030 0.0555 0.2835)
+(0.0060 0.0555 0.2835)
+(-0.0060 0.0585 0.2835)
+(-0.0030 0.0585 0.2835)
+(0.0000 0.0585 0.2835)
+(0.0030 0.0585 0.2835)
+(0.0060 0.0585 0.2835)
+(-0.0060 0.0615 0.2835)
+(-0.0030 0.0615 0.2835)
+(0.0000 0.0615 0.2835)
+(0.0030 0.0615 0.2835)
+(0.0060 0.0615 0.2835)
+(-0.0060 0.0645 0.2835)
+(-0.0030 0.0645 0.2835)
+(0.0000 0.0645 0.2835)
+(0.0030 0.0645 0.2835)
+(0.0060 0.0645 0.2835)
+(-0.0060 0.0675 0.2835)
+(-0.0030 0.0675 0.2835)
+(0.0000 0.0675 0.2835)
+(0.0030 0.0675 0.2835)
+(0.0060 0.0675 0.2835)
+(-0.0060 0.0705 0.2835)
+(-0.0030 0.0705 0.2835)
+(0.0000 0.0705 0.2835)
+(0.0030 0.0705 0.2835)
+(0.0060 0.0705 0.2835)
+(-0.0060 0.0735 0.2835)
+(-0.0030 0.0735 0.2835)
+(0.0000 0.0735 0.2835)
+(0.0030 0.0735 0.2835)
+(0.0060 0.0735 0.2835)
+(-0.0060 -0.0735 0.2865)
+(-0.0030 -0.0735 0.2865)
+(0.0000 -0.0735 0.2865)
+(0.0030 -0.0735 0.2865)
+(0.0060 -0.0735 0.2865)
+(-0.0060 -0.0705 0.2865)
+(-0.0030 -0.0705 0.2865)
+(0.0000 -0.0705 0.2865)
+(0.0030 -0.0705 0.2865)
+(0.0060 -0.0705 0.2865)
+(-0.0060 -0.0675 0.2865)
+(-0.0030 -0.0675 0.2865)
+(0.0000 -0.0675 0.2865)
+(0.0030 -0.0675 0.2865)
+(0.0060 -0.0675 0.2865)
+(-0.0060 -0.0645 0.2865)
+(-0.0030 -0.0645 0.2865)
+(0.0000 -0.0645 0.2865)
+(0.0030 -0.0645 0.2865)
+(0.0060 -0.0645 0.2865)
+(-0.0060 -0.0615 0.2865)
+(-0.0030 -0.0615 0.2865)
+(0.0000 -0.0615 0.2865)
+(0.0030 -0.0615 0.2865)
+(0.0060 -0.0615 0.2865)
+(-0.0060 -0.0585 0.2865)
+(-0.0030 -0.0585 0.2865)
+(0.0000 -0.0585 0.2865)
+(0.0030 -0.0585 0.2865)
+(0.0060 -0.0585 0.2865)
+(-0.0060 -0.0555 0.2865)
+(-0.0030 -0.0555 0.2865)
+(0.0000 -0.0555 0.2865)
+(0.0030 -0.0555 0.2865)
+(0.0060 -0.0555 0.2865)
+(-0.0060 -0.0525 0.2865)
+(-0.0030 -0.0525 0.2865)
+(0.0000 -0.0525 0.2865)
+(0.0030 -0.0525 0.2865)
+(0.0060 -0.0525 0.2865)
+(-0.0060 -0.0495 0.2865)
+(-0.0030 -0.0495 0.2865)
+(0.0000 -0.0495 0.2865)
+(0.0030 -0.0495 0.2865)
+(0.0060 -0.0495 0.2865)
+(-0.0060 -0.0465 0.2865)
+(-0.0030 -0.0465 0.2865)
+(0.0000 -0.0465 0.2865)
+(0.0030 -0.0465 0.2865)
+(0.0060 -0.0465 0.2865)
+(-0.0060 -0.0435 0.2865)
+(-0.0030 -0.0435 0.2865)
+(0.0000 -0.0435 0.2865)
+(0.0030 -0.0435 0.2865)
+(0.0060 -0.0435 0.2865)
+(-0.0060 -0.0405 0.2865)
+(-0.0030 -0.0405 0.2865)
+(0.0000 -0.0405 0.2865)
+(0.0030 -0.0405 0.2865)
+(0.0060 -0.0405 0.2865)
+(-0.0060 -0.0375 0.2865)
+(-0.0030 -0.0375 0.2865)
+(0.0000 -0.0375 0.2865)
+(0.0030 -0.0375 0.2865)
+(0.0060 -0.0375 0.2865)
+(-0.0060 -0.0345 0.2865)
+(-0.0030 -0.0345 0.2865)
+(0.0000 -0.0345 0.2865)
+(0.0030 -0.0345 0.2865)
+(0.0060 -0.0345 0.2865)
+(-0.0060 -0.0315 0.2865)
+(-0.0030 -0.0315 0.2865)
+(0.0000 -0.0315 0.2865)
+(0.0030 -0.0315 0.2865)
+(0.0060 -0.0315 0.2865)
+(-0.0060 -0.0285 0.2865)
+(-0.0030 -0.0285 0.2865)
+(0.0000 -0.0285 0.2865)
+(0.0030 -0.0285 0.2865)
+(0.0060 -0.0285 0.2865)
+(-0.0060 -0.0255 0.2865)
+(-0.0030 -0.0255 0.2865)
+(0.0000 -0.0255 0.2865)
+(0.0030 -0.0255 0.2865)
+(0.0060 -0.0255 0.2865)
+(-0.0060 -0.0225 0.2865)
+(-0.0030 -0.0225 0.2865)
+(0.0000 -0.0225 0.2865)
+(0.0030 -0.0225 0.2865)
+(0.0060 -0.0225 0.2865)
+(-0.0060 -0.0195 0.2865)
+(-0.0030 -0.0195 0.2865)
+(0.0000 -0.0195 0.2865)
+(0.0030 -0.0195 0.2865)
+(0.0060 -0.0195 0.2865)
+(-0.0060 -0.0165 0.2865)
+(-0.0030 -0.0165 0.2865)
+(0.0000 -0.0165 0.2865)
+(0.0030 -0.0165 0.2865)
+(0.0060 -0.0165 0.2865)
+(-0.0060 -0.0135 0.2865)
+(-0.0030 -0.0135 0.2865)
+(0.0000 -0.0135 0.2865)
+(0.0030 -0.0135 0.2865)
+(0.0060 -0.0135 0.2865)
+(-0.0060 -0.0105 0.2865)
+(-0.0030 -0.0105 0.2865)
+(0.0000 -0.0105 0.2865)
+(0.0030 -0.0105 0.2865)
+(0.0060 -0.0105 0.2865)
+(-0.0060 -0.0075 0.2865)
+(-0.0030 -0.0075 0.2865)
+(0.0000 -0.0075 0.2865)
+(0.0030 -0.0075 0.2865)
+(0.0060 -0.0075 0.2865)
+(-0.0060 -0.0045 0.2865)
+(-0.0030 -0.0045 0.2865)
+(0.0000 -0.0045 0.2865)
+(0.0030 -0.0045 0.2865)
+(0.0060 -0.0045 0.2865)
+(-0.0060 -0.0015 0.2865)
+(-0.0030 -0.0015 0.2865)
+(0.0000 -0.0015 0.2865)
+(0.0030 -0.0015 0.2865)
+(0.0060 -0.0015 0.2865)
+(-0.0060 0.0015 0.2865)
+(-0.0030 0.0015 0.2865)
+(0.0000 0.0015 0.2865)
+(0.0030 0.0015 0.2865)
+(0.0060 0.0015 0.2865)
+(-0.0060 0.0045 0.2865)
+(-0.0030 0.0045 0.2865)
+(0.0000 0.0045 0.2865)
+(0.0030 0.0045 0.2865)
+(0.0060 0.0045 0.2865)
+(-0.0060 0.0075 0.2865)
+(-0.0030 0.0075 0.2865)
+(0.0000 0.0075 0.2865)
+(0.0030 0.0075 0.2865)
+(0.0060 0.0075 0.2865)
+(-0.0060 0.0105 0.2865)
+(-0.0030 0.0105 0.2865)
+(0.0000 0.0105 0.2865)
+(0.0030 0.0105 0.2865)
+(0.0060 0.0105 0.2865)
+(-0.0060 0.0135 0.2865)
+(-0.0030 0.0135 0.2865)
+(0.0000 0.0135 0.2865)
+(0.0030 0.0135 0.2865)
+(0.0060 0.0135 0.2865)
+(-0.0060 0.0165 0.2865)
+(-0.0030 0.0165 0.2865)
+(0.0000 0.0165 0.2865)
+(0.0030 0.0165 0.2865)
+(0.0060 0.0165 0.2865)
+(-0.0060 0.0195 0.2865)
+(-0.0030 0.0195 0.2865)
+(0.0000 0.0195 0.2865)
+(0.0030 0.0195 0.2865)
+(0.0060 0.0195 0.2865)
+(-0.0060 0.0225 0.2865)
+(-0.0030 0.0225 0.2865)
+(0.0000 0.0225 0.2865)
+(0.0030 0.0225 0.2865)
+(0.0060 0.0225 0.2865)
+(-0.0060 0.0255 0.2865)
+(-0.0030 0.0255 0.2865)
+(0.0000 0.0255 0.2865)
+(0.0030 0.0255 0.2865)
+(0.0060 0.0255 0.2865)
+(-0.0060 0.0285 0.2865)
+(-0.0030 0.0285 0.2865)
+(0.0000 0.0285 0.2865)
+(0.0030 0.0285 0.2865)
+(0.0060 0.0285 0.2865)
+(-0.0060 0.0315 0.2865)
+(-0.0030 0.0315 0.2865)
+(0.0000 0.0315 0.2865)
+(0.0030 0.0315 0.2865)
+(0.0060 0.0315 0.2865)
+(-0.0060 0.0345 0.2865)
+(-0.0030 0.0345 0.2865)
+(0.0000 0.0345 0.2865)
+(0.0030 0.0345 0.2865)
+(0.0060 0.0345 0.2865)
+(-0.0060 0.0375 0.2865)
+(-0.0030 0.0375 0.2865)
+(0.0000 0.0375 0.2865)
+(0.0030 0.0375 0.2865)
+(0.0060 0.0375 0.2865)
+(-0.0060 0.0405 0.2865)
+(-0.0030 0.0405 0.2865)
+(0.0000 0.0405 0.2865)
+(0.0030 0.0405 0.2865)
+(0.0060 0.0405 0.2865)
+(-0.0060 0.0435 0.2865)
+(-0.0030 0.0435 0.2865)
+(0.0000 0.0435 0.2865)
+(0.0030 0.0435 0.2865)
+(0.0060 0.0435 0.2865)
+(-0.0060 0.0465 0.2865)
+(-0.0030 0.0465 0.2865)
+(0.0000 0.0465 0.2865)
+(0.0030 0.0465 0.2865)
+(0.0060 0.0465 0.2865)
+(-0.0060 0.0495 0.2865)
+(-0.0030 0.0495 0.2865)
+(0.0000 0.0495 0.2865)
+(0.0030 0.0495 0.2865)
+(0.0060 0.0495 0.2865)
+(-0.0060 0.0525 0.2865)
+(-0.0030 0.0525 0.2865)
+(0.0000 0.0525 0.2865)
+(0.0030 0.0525 0.2865)
+(0.0060 0.0525 0.2865)
+(-0.0060 0.0555 0.2865)
+(-0.0030 0.0555 0.2865)
+(0.0000 0.0555 0.2865)
+(0.0030 0.0555 0.2865)
+(0.0060 0.0555 0.2865)
+(-0.0060 0.0585 0.2865)
+(-0.0030 0.0585 0.2865)
+(0.0000 0.0585 0.2865)
+(0.0030 0.0585 0.2865)
+(0.0060 0.0585 0.2865)
+(-0.0060 0.0615 0.2865)
+(-0.0030 0.0615 0.2865)
+(0.0000 0.0615 0.2865)
+(0.0030 0.0615 0.2865)
+(0.0060 0.0615 0.2865)
+(-0.0060 0.0645 0.2865)
+(-0.0030 0.0645 0.2865)
+(0.0000 0.0645 0.2865)
+(0.0030 0.0645 0.2865)
+(0.0060 0.0645 0.2865)
+(-0.0060 0.0675 0.2865)
+(-0.0030 0.0675 0.2865)
+(0.0000 0.0675 0.2865)
+(0.0030 0.0675 0.2865)
+(0.0060 0.0675 0.2865)
+(-0.0060 0.0705 0.2865)
+(-0.0030 0.0705 0.2865)
+(0.0000 0.0705 0.2865)
+(0.0030 0.0705 0.2865)
+(0.0060 0.0705 0.2865)
+(-0.0060 0.0735 0.2865)
+(-0.0030 0.0735 0.2865)
+(0.0000 0.0735 0.2865)
+(0.0030 0.0735 0.2865)
+(0.0060 0.0735 0.2865)
+(-0.0060 -0.0735 0.2895)
+(-0.0030 -0.0735 0.2895)
+(0.0000 -0.0735 0.2895)
+(0.0030 -0.0735 0.2895)
+(0.0060 -0.0735 0.2895)
+(-0.0060 -0.0705 0.2895)
+(-0.0030 -0.0705 0.2895)
+(0.0000 -0.0705 0.2895)
+(0.0030 -0.0705 0.2895)
+(0.0060 -0.0705 0.2895)
+(-0.0060 -0.0675 0.2895)
+(-0.0030 -0.0675 0.2895)
+(0.0000 -0.0675 0.2895)
+(0.0030 -0.0675 0.2895)
+(0.0060 -0.0675 0.2895)
+(-0.0060 -0.0645 0.2895)
+(-0.0030 -0.0645 0.2895)
+(0.0000 -0.0645 0.2895)
+(0.0030 -0.0645 0.2895)
+(0.0060 -0.0645 0.2895)
+(-0.0060 -0.0615 0.2895)
+(-0.0030 -0.0615 0.2895)
+(0.0000 -0.0615 0.2895)
+(0.0030 -0.0615 0.2895)
+(0.0060 -0.0615 0.2895)
+(-0.0060 -0.0585 0.2895)
+(-0.0030 -0.0585 0.2895)
+(0.0000 -0.0585 0.2895)
+(0.0030 -0.0585 0.2895)
+(0.0060 -0.0585 0.2895)
+(-0.0060 -0.0555 0.2895)
+(-0.0030 -0.0555 0.2895)
+(0.0000 -0.0555 0.2895)
+(0.0030 -0.0555 0.2895)
+(0.0060 -0.0555 0.2895)
+(-0.0060 -0.0525 0.2895)
+(-0.0030 -0.0525 0.2895)
+(0.0000 -0.0525 0.2895)
+(0.0030 -0.0525 0.2895)
+(0.0060 -0.0525 0.2895)
+(-0.0060 -0.0495 0.2895)
+(-0.0030 -0.0495 0.2895)
+(0.0000 -0.0495 0.2895)
+(0.0030 -0.0495 0.2895)
+(0.0060 -0.0495 0.2895)
+(-0.0060 -0.0465 0.2895)
+(-0.0030 -0.0465 0.2895)
+(0.0000 -0.0465 0.2895)
+(0.0030 -0.0465 0.2895)
+(0.0060 -0.0465 0.2895)
+(-0.0060 -0.0435 0.2895)
+(-0.0030 -0.0435 0.2895)
+(0.0000 -0.0435 0.2895)
+(0.0030 -0.0435 0.2895)
+(0.0060 -0.0435 0.2895)
+(-0.0060 -0.0405 0.2895)
+(-0.0030 -0.0405 0.2895)
+(0.0000 -0.0405 0.2895)
+(0.0030 -0.0405 0.2895)
+(0.0060 -0.0405 0.2895)
+(-0.0060 -0.0375 0.2895)
+(-0.0030 -0.0375 0.2895)
+(0.0000 -0.0375 0.2895)
+(0.0030 -0.0375 0.2895)
+(0.0060 -0.0375 0.2895)
+(-0.0060 -0.0345 0.2895)
+(-0.0030 -0.0345 0.2895)
+(0.0000 -0.0345 0.2895)
+(0.0030 -0.0345 0.2895)
+(0.0060 -0.0345 0.2895)
+(-0.0060 -0.0315 0.2895)
+(-0.0030 -0.0315 0.2895)
+(0.0000 -0.0315 0.2895)
+(0.0030 -0.0315 0.2895)
+(0.0060 -0.0315 0.2895)
+(-0.0060 -0.0285 0.2895)
+(-0.0030 -0.0285 0.2895)
+(0.0000 -0.0285 0.2895)
+(0.0030 -0.0285 0.2895)
+(0.0060 -0.0285 0.2895)
+(-0.0060 -0.0255 0.2895)
+(-0.0030 -0.0255 0.2895)
+(0.0000 -0.0255 0.2895)
+(0.0030 -0.0255 0.2895)
+(0.0060 -0.0255 0.2895)
+(-0.0060 -0.0225 0.2895)
+(-0.0030 -0.0225 0.2895)
+(0.0000 -0.0225 0.2895)
+(0.0030 -0.0225 0.2895)
+(0.0060 -0.0225 0.2895)
+(-0.0060 -0.0195 0.2895)
+(-0.0030 -0.0195 0.2895)
+(0.0000 -0.0195 0.2895)
+(0.0030 -0.0195 0.2895)
+(0.0060 -0.0195 0.2895)
+(-0.0060 -0.0165 0.2895)
+(-0.0030 -0.0165 0.2895)
+(0.0000 -0.0165 0.2895)
+(0.0030 -0.0165 0.2895)
+(0.0060 -0.0165 0.2895)
+(-0.0060 -0.0135 0.2895)
+(-0.0030 -0.0135 0.2895)
+(0.0000 -0.0135 0.2895)
+(0.0030 -0.0135 0.2895)
+(0.0060 -0.0135 0.2895)
+(-0.0060 -0.0105 0.2895)
+(-0.0030 -0.0105 0.2895)
+(0.0000 -0.0105 0.2895)
+(0.0030 -0.0105 0.2895)
+(0.0060 -0.0105 0.2895)
+(-0.0060 -0.0075 0.2895)
+(-0.0030 -0.0075 0.2895)
+(0.0000 -0.0075 0.2895)
+(0.0030 -0.0075 0.2895)
+(0.0060 -0.0075 0.2895)
+(-0.0060 -0.0045 0.2895)
+(-0.0030 -0.0045 0.2895)
+(0.0000 -0.0045 0.2895)
+(0.0030 -0.0045 0.2895)
+(0.0060 -0.0045 0.2895)
+(-0.0060 -0.0015 0.2895)
+(-0.0030 -0.0015 0.2895)
+(0.0000 -0.0015 0.2895)
+(0.0030 -0.0015 0.2895)
+(0.0060 -0.0015 0.2895)
+(-0.0060 0.0015 0.2895)
+(-0.0030 0.0015 0.2895)
+(0.0000 0.0015 0.2895)
+(0.0030 0.0015 0.2895)
+(0.0060 0.0015 0.2895)
+(-0.0060 0.0045 0.2895)
+(-0.0030 0.0045 0.2895)
+(0.0000 0.0045 0.2895)
+(0.0030 0.0045 0.2895)
+(0.0060 0.0045 0.2895)
+(-0.0060 0.0075 0.2895)
+(-0.0030 0.0075 0.2895)
+(0.0000 0.0075 0.2895)
+(0.0030 0.0075 0.2895)
+(0.0060 0.0075 0.2895)
+(-0.0060 0.0105 0.2895)
+(-0.0030 0.0105 0.2895)
+(0.0000 0.0105 0.2895)
+(0.0030 0.0105 0.2895)
+(0.0060 0.0105 0.2895)
+(-0.0060 0.0135 0.2895)
+(-0.0030 0.0135 0.2895)
+(0.0000 0.0135 0.2895)
+(0.0030 0.0135 0.2895)
+(0.0060 0.0135 0.2895)
+(-0.0060 0.0165 0.2895)
+(-0.0030 0.0165 0.2895)
+(0.0000 0.0165 0.2895)
+(0.0030 0.0165 0.2895)
+(0.0060 0.0165 0.2895)
+(-0.0060 0.0195 0.2895)
+(-0.0030 0.0195 0.2895)
+(0.0000 0.0195 0.2895)
+(0.0030 0.0195 0.2895)
+(0.0060 0.0195 0.2895)
+(-0.0060 0.0225 0.2895)
+(-0.0030 0.0225 0.2895)
+(0.0000 0.0225 0.2895)
+(0.0030 0.0225 0.2895)
+(0.0060 0.0225 0.2895)
+(-0.0060 0.0255 0.2895)
+(-0.0030 0.0255 0.2895)
+(0.0000 0.0255 0.2895)
+(0.0030 0.0255 0.2895)
+(0.0060 0.0255 0.2895)
+(-0.0060 0.0285 0.2895)
+(-0.0030 0.0285 0.2895)
+(0.0000 0.0285 0.2895)
+(0.0030 0.0285 0.2895)
+(0.0060 0.0285 0.2895)
+(-0.0060 0.0315 0.2895)
+(-0.0030 0.0315 0.2895)
+(0.0000 0.0315 0.2895)
+(0.0030 0.0315 0.2895)
+(0.0060 0.0315 0.2895)
+(-0.0060 0.0345 0.2895)
+(-0.0030 0.0345 0.2895)
+(0.0000 0.0345 0.2895)
+(0.0030 0.0345 0.2895)
+(0.0060 0.0345 0.2895)
+(-0.0060 0.0375 0.2895)
+(-0.0030 0.0375 0.2895)
+(0.0000 0.0375 0.2895)
+(0.0030 0.0375 0.2895)
+(0.0060 0.0375 0.2895)
+(-0.0060 0.0405 0.2895)
+(-0.0030 0.0405 0.2895)
+(0.0000 0.0405 0.2895)
+(0.0030 0.0405 0.2895)
+(0.0060 0.0405 0.2895)
+(-0.0060 0.0435 0.2895)
+(-0.0030 0.0435 0.2895)
+(0.0000 0.0435 0.2895)
+(0.0030 0.0435 0.2895)
+(0.0060 0.0435 0.2895)
+(-0.0060 0.0465 0.2895)
+(-0.0030 0.0465 0.2895)
+(0.0000 0.0465 0.2895)
+(0.0030 0.0465 0.2895)
+(0.0060 0.0465 0.2895)
+(-0.0060 0.0495 0.2895)
+(-0.0030 0.0495 0.2895)
+(0.0000 0.0495 0.2895)
+(0.0030 0.0495 0.2895)
+(0.0060 0.0495 0.2895)
+(-0.0060 0.0525 0.2895)
+(-0.0030 0.0525 0.2895)
+(0.0000 0.0525 0.2895)
+(0.0030 0.0525 0.2895)
+(0.0060 0.0525 0.2895)
+(-0.0060 0.0555 0.2895)
+(-0.0030 0.0555 0.2895)
+(0.0000 0.0555 0.2895)
+(0.0030 0.0555 0.2895)
+(0.0060 0.0555 0.2895)
+(-0.0060 0.0585 0.2895)
+(-0.0030 0.0585 0.2895)
+(0.0000 0.0585 0.2895)
+(0.0030 0.0585 0.2895)
+(0.0060 0.0585 0.2895)
+(-0.0060 0.0615 0.2895)
+(-0.0030 0.0615 0.2895)
+(0.0000 0.0615 0.2895)
+(0.0030 0.0615 0.2895)
+(0.0060 0.0615 0.2895)
+(-0.0060 0.0645 0.2895)
+(-0.0030 0.0645 0.2895)
+(0.0000 0.0645 0.2895)
+(0.0030 0.0645 0.2895)
+(0.0060 0.0645 0.2895)
+(-0.0060 0.0675 0.2895)
+(-0.0030 0.0675 0.2895)
+(0.0000 0.0675 0.2895)
+(0.0030 0.0675 0.2895)
+(0.0060 0.0675 0.2895)
+(-0.0060 0.0705 0.2895)
+(-0.0030 0.0705 0.2895)
+(0.0000 0.0705 0.2895)
+(0.0030 0.0705 0.2895)
+(0.0060 0.0705 0.2895)
+(-0.0060 0.0735 0.2895)
+(-0.0030 0.0735 0.2895)
+(0.0000 0.0735 0.2895)
+(0.0030 0.0735 0.2895)
+(0.0060 0.0735 0.2895)
+(-0.0060 -0.0735 0.2925)
+(-0.0030 -0.0735 0.2925)
+(0.0000 -0.0735 0.2925)
+(0.0030 -0.0735 0.2925)
+(0.0060 -0.0735 0.2925)
+(-0.0060 -0.0705 0.2925)
+(-0.0030 -0.0705 0.2925)
+(0.0000 -0.0705 0.2925)
+(0.0030 -0.0705 0.2925)
+(0.0060 -0.0705 0.2925)
+(-0.0060 -0.0675 0.2925)
+(-0.0030 -0.0675 0.2925)
+(0.0000 -0.0675 0.2925)
+(0.0030 -0.0675 0.2925)
+(0.0060 -0.0675 0.2925)
+(-0.0060 -0.0645 0.2925)
+(-0.0030 -0.0645 0.2925)
+(0.0000 -0.0645 0.2925)
+(0.0030 -0.0645 0.2925)
+(0.0060 -0.0645 0.2925)
+(-0.0060 -0.0615 0.2925)
+(-0.0030 -0.0615 0.2925)
+(0.0000 -0.0615 0.2925)
+(0.0030 -0.0615 0.2925)
+(0.0060 -0.0615 0.2925)
+(-0.0060 -0.0585 0.2925)
+(-0.0030 -0.0585 0.2925)
+(0.0000 -0.0585 0.2925)
+(0.0030 -0.0585 0.2925)
+(0.0060 -0.0585 0.2925)
+(-0.0060 -0.0555 0.2925)
+(-0.0030 -0.0555 0.2925)
+(0.0000 -0.0555 0.2925)
+(0.0030 -0.0555 0.2925)
+(0.0060 -0.0555 0.2925)
+(-0.0060 -0.0525 0.2925)
+(-0.0030 -0.0525 0.2925)
+(0.0000 -0.0525 0.2925)
+(0.0030 -0.0525 0.2925)
+(0.0060 -0.0525 0.2925)
+(-0.0060 -0.0495 0.2925)
+(-0.0030 -0.0495 0.2925)
+(0.0000 -0.0495 0.2925)
+(0.0030 -0.0495 0.2925)
+(0.0060 -0.0495 0.2925)
+(-0.0060 -0.0465 0.2925)
+(-0.0030 -0.0465 0.2925)
+(0.0000 -0.0465 0.2925)
+(0.0030 -0.0465 0.2925)
+(0.0060 -0.0465 0.2925)
+(-0.0060 -0.0435 0.2925)
+(-0.0030 -0.0435 0.2925)
+(0.0000 -0.0435 0.2925)
+(0.0030 -0.0435 0.2925)
+(0.0060 -0.0435 0.2925)
+(-0.0060 -0.0405 0.2925)
+(-0.0030 -0.0405 0.2925)
+(0.0000 -0.0405 0.2925)
+(0.0030 -0.0405 0.2925)
+(0.0060 -0.0405 0.2925)
+(-0.0060 -0.0375 0.2925)
+(-0.0030 -0.0375 0.2925)
+(0.0000 -0.0375 0.2925)
+(0.0030 -0.0375 0.2925)
+(0.0060 -0.0375 0.2925)
+(-0.0060 -0.0345 0.2925)
+(-0.0030 -0.0345 0.2925)
+(0.0000 -0.0345 0.2925)
+(0.0030 -0.0345 0.2925)
+(0.0060 -0.0345 0.2925)
+(-0.0060 -0.0315 0.2925)
+(-0.0030 -0.0315 0.2925)
+(0.0000 -0.0315 0.2925)
+(0.0030 -0.0315 0.2925)
+(0.0060 -0.0315 0.2925)
+(-0.0060 -0.0285 0.2925)
+(-0.0030 -0.0285 0.2925)
+(0.0000 -0.0285 0.2925)
+(0.0030 -0.0285 0.2925)
+(0.0060 -0.0285 0.2925)
+(-0.0060 -0.0255 0.2925)
+(-0.0030 -0.0255 0.2925)
+(0.0000 -0.0255 0.2925)
+(0.0030 -0.0255 0.2925)
+(0.0060 -0.0255 0.2925)
+(-0.0060 -0.0225 0.2925)
+(-0.0030 -0.0225 0.2925)
+(0.0000 -0.0225 0.2925)
+(0.0030 -0.0225 0.2925)
+(0.0060 -0.0225 0.2925)
+(-0.0060 -0.0195 0.2925)
+(-0.0030 -0.0195 0.2925)
+(0.0000 -0.0195 0.2925)
+(0.0030 -0.0195 0.2925)
+(0.0060 -0.0195 0.2925)
+(-0.0060 -0.0165 0.2925)
+(-0.0030 -0.0165 0.2925)
+(0.0000 -0.0165 0.2925)
+(0.0030 -0.0165 0.2925)
+(0.0060 -0.0165 0.2925)
+(-0.0060 -0.0135 0.2925)
+(-0.0030 -0.0135 0.2925)
+(0.0000 -0.0135 0.2925)
+(0.0030 -0.0135 0.2925)
+(0.0060 -0.0135 0.2925)
+(-0.0060 -0.0105 0.2925)
+(-0.0030 -0.0105 0.2925)
+(0.0000 -0.0105 0.2925)
+(0.0030 -0.0105 0.2925)
+(0.0060 -0.0105 0.2925)
+(-0.0060 -0.0075 0.2925)
+(-0.0030 -0.0075 0.2925)
+(0.0000 -0.0075 0.2925)
+(0.0030 -0.0075 0.2925)
+(0.0060 -0.0075 0.2925)
+(-0.0060 -0.0045 0.2925)
+(-0.0030 -0.0045 0.2925)
+(0.0000 -0.0045 0.2925)
+(0.0030 -0.0045 0.2925)
+(0.0060 -0.0045 0.2925)
+(-0.0060 -0.0015 0.2925)
+(-0.0030 -0.0015 0.2925)
+(0.0000 -0.0015 0.2925)
+(0.0030 -0.0015 0.2925)
+(0.0060 -0.0015 0.2925)
+(-0.0060 0.0015 0.2925)
+(-0.0030 0.0015 0.2925)
+(0.0000 0.0015 0.2925)
+(0.0030 0.0015 0.2925)
+(0.0060 0.0015 0.2925)
+(-0.0060 0.0045 0.2925)
+(-0.0030 0.0045 0.2925)
+(0.0000 0.0045 0.2925)
+(0.0030 0.0045 0.2925)
+(0.0060 0.0045 0.2925)
+(-0.0060 0.0075 0.2925)
+(-0.0030 0.0075 0.2925)
+(0.0000 0.0075 0.2925)
+(0.0030 0.0075 0.2925)
+(0.0060 0.0075 0.2925)
+(-0.0060 0.0105 0.2925)
+(-0.0030 0.0105 0.2925)
+(0.0000 0.0105 0.2925)
+(0.0030 0.0105 0.2925)
+(0.0060 0.0105 0.2925)
+(-0.0060 0.0135 0.2925)
+(-0.0030 0.0135 0.2925)
+(0.0000 0.0135 0.2925)
+(0.0030 0.0135 0.2925)
+(0.0060 0.0135 0.2925)
+(-0.0060 0.0165 0.2925)
+(-0.0030 0.0165 0.2925)
+(0.0000 0.0165 0.2925)
+(0.0030 0.0165 0.2925)
+(0.0060 0.0165 0.2925)
+(-0.0060 0.0195 0.2925)
+(-0.0030 0.0195 0.2925)
+(0.0000 0.0195 0.2925)
+(0.0030 0.0195 0.2925)
+(0.0060 0.0195 0.2925)
+(-0.0060 0.0225 0.2925)
+(-0.0030 0.0225 0.2925)
+(0.0000 0.0225 0.2925)
+(0.0030 0.0225 0.2925)
+(0.0060 0.0225 0.2925)
+(-0.0060 0.0255 0.2925)
+(-0.0030 0.0255 0.2925)
+(0.0000 0.0255 0.2925)
+(0.0030 0.0255 0.2925)
+(0.0060 0.0255 0.2925)
+(-0.0060 0.0285 0.2925)
+(-0.0030 0.0285 0.2925)
+(0.0000 0.0285 0.2925)
+(0.0030 0.0285 0.2925)
+(0.0060 0.0285 0.2925)
+(-0.0060 0.0315 0.2925)
+(-0.0030 0.0315 0.2925)
+(0.0000 0.0315 0.2925)
+(0.0030 0.0315 0.2925)
+(0.0060 0.0315 0.2925)
+(-0.0060 0.0345 0.2925)
+(-0.0030 0.0345 0.2925)
+(0.0000 0.0345 0.2925)
+(0.0030 0.0345 0.2925)
+(0.0060 0.0345 0.2925)
+(-0.0060 0.0375 0.2925)
+(-0.0030 0.0375 0.2925)
+(0.0000 0.0375 0.2925)
+(0.0030 0.0375 0.2925)
+(0.0060 0.0375 0.2925)
+(-0.0060 0.0405 0.2925)
+(-0.0030 0.0405 0.2925)
+(0.0000 0.0405 0.2925)
+(0.0030 0.0405 0.2925)
+(0.0060 0.0405 0.2925)
+(-0.0060 0.0435 0.2925)
+(-0.0030 0.0435 0.2925)
+(0.0000 0.0435 0.2925)
+(0.0030 0.0435 0.2925)
+(0.0060 0.0435 0.2925)
+(-0.0060 0.0465 0.2925)
+(-0.0030 0.0465 0.2925)
+(0.0000 0.0465 0.2925)
+(0.0030 0.0465 0.2925)
+(0.0060 0.0465 0.2925)
+(-0.0060 0.0495 0.2925)
+(-0.0030 0.0495 0.2925)
+(0.0000 0.0495 0.2925)
+(0.0030 0.0495 0.2925)
+(0.0060 0.0495 0.2925)
+(-0.0060 0.0525 0.2925)
+(-0.0030 0.0525 0.2925)
+(0.0000 0.0525 0.2925)
+(0.0030 0.0525 0.2925)
+(0.0060 0.0525 0.2925)
+(-0.0060 0.0555 0.2925)
+(-0.0030 0.0555 0.2925)
+(0.0000 0.0555 0.2925)
+(0.0030 0.0555 0.2925)
+(0.0060 0.0555 0.2925)
+(-0.0060 0.0585 0.2925)
+(-0.0030 0.0585 0.2925)
+(0.0000 0.0585 0.2925)
+(0.0030 0.0585 0.2925)
+(0.0060 0.0585 0.2925)
+(-0.0060 0.0615 0.2925)
+(-0.0030 0.0615 0.2925)
+(0.0000 0.0615 0.2925)
+(0.0030 0.0615 0.2925)
+(0.0060 0.0615 0.2925)
+(-0.0060 0.0645 0.2925)
+(-0.0030 0.0645 0.2925)
+(0.0000 0.0645 0.2925)
+(0.0030 0.0645 0.2925)
+(0.0060 0.0645 0.2925)
+(-0.0060 0.0675 0.2925)
+(-0.0030 0.0675 0.2925)
+(0.0000 0.0675 0.2925)
+(0.0030 0.0675 0.2925)
+(0.0060 0.0675 0.2925)
+(-0.0060 0.0705 0.2925)
+(-0.0030 0.0705 0.2925)
+(0.0000 0.0705 0.2925)
+(0.0030 0.0705 0.2925)
+(0.0060 0.0705 0.2925)
+(-0.0060 0.0735 0.2925)
+(-0.0030 0.0735 0.2925)
+(0.0000 0.0735 0.2925)
+(0.0030 0.0735 0.2925)
+(0.0060 0.0735 0.2925)
+(-0.0060 -0.0735 0.2955)
+(-0.0030 -0.0735 0.2955)
+(0.0000 -0.0735 0.2955)
+(0.0030 -0.0735 0.2955)
+(0.0060 -0.0735 0.2955)
+(-0.0060 -0.0705 0.2955)
+(-0.0030 -0.0705 0.2955)
+(0.0000 -0.0705 0.2955)
+(0.0030 -0.0705 0.2955)
+(0.0060 -0.0705 0.2955)
+(-0.0060 -0.0675 0.2955)
+(-0.0030 -0.0675 0.2955)
+(0.0000 -0.0675 0.2955)
+(0.0030 -0.0675 0.2955)
+(0.0060 -0.0675 0.2955)
+(-0.0060 -0.0645 0.2955)
+(-0.0030 -0.0645 0.2955)
+(0.0000 -0.0645 0.2955)
+(0.0030 -0.0645 0.2955)
+(0.0060 -0.0645 0.2955)
+(-0.0060 -0.0615 0.2955)
+(-0.0030 -0.0615 0.2955)
+(0.0000 -0.0615 0.2955)
+(0.0030 -0.0615 0.2955)
+(0.0060 -0.0615 0.2955)
+(-0.0060 -0.0585 0.2955)
+(-0.0030 -0.0585 0.2955)
+(0.0000 -0.0585 0.2955)
+(0.0030 -0.0585 0.2955)
+(0.0060 -0.0585 0.2955)
+(-0.0060 -0.0555 0.2955)
+(-0.0030 -0.0555 0.2955)
+(0.0000 -0.0555 0.2955)
+(0.0030 -0.0555 0.2955)
+(0.0060 -0.0555 0.2955)
+(-0.0060 -0.0525 0.2955)
+(-0.0030 -0.0525 0.2955)
+(0.0000 -0.0525 0.2955)
+(0.0030 -0.0525 0.2955)
+(0.0060 -0.0525 0.2955)
+(-0.0060 -0.0495 0.2955)
+(-0.0030 -0.0495 0.2955)
+(0.0000 -0.0495 0.2955)
+(0.0030 -0.0495 0.2955)
+(0.0060 -0.0495 0.2955)
+(-0.0060 -0.0465 0.2955)
+(-0.0030 -0.0465 0.2955)
+(0.0000 -0.0465 0.2955)
+(0.0030 -0.0465 0.2955)
+(0.0060 -0.0465 0.2955)
+(-0.0060 -0.0435 0.2955)
+(-0.0030 -0.0435 0.2955)
+(0.0000 -0.0435 0.2955)
+(0.0030 -0.0435 0.2955)
+(0.0060 -0.0435 0.2955)
+(-0.0060 -0.0405 0.2955)
+(-0.0030 -0.0405 0.2955)
+(0.0000 -0.0405 0.2955)
+(0.0030 -0.0405 0.2955)
+(0.0060 -0.0405 0.2955)
+(-0.0060 -0.0375 0.2955)
+(-0.0030 -0.0375 0.2955)
+(0.0000 -0.0375 0.2955)
+(0.0030 -0.0375 0.2955)
+(0.0060 -0.0375 0.2955)
+(-0.0060 -0.0345 0.2955)
+(-0.0030 -0.0345 0.2955)
+(0.0000 -0.0345 0.2955)
+(0.0030 -0.0345 0.2955)
+(0.0060 -0.0345 0.2955)
+(-0.0060 -0.0315 0.2955)
+(-0.0030 -0.0315 0.2955)
+(0.0000 -0.0315 0.2955)
+(0.0030 -0.0315 0.2955)
+(0.0060 -0.0315 0.2955)
+(-0.0060 -0.0285 0.2955)
+(-0.0030 -0.0285 0.2955)
+(0.0000 -0.0285 0.2955)
+(0.0030 -0.0285 0.2955)
+(0.0060 -0.0285 0.2955)
+(-0.0060 -0.0255 0.2955)
+(-0.0030 -0.0255 0.2955)
+(0.0000 -0.0255 0.2955)
+(0.0030 -0.0255 0.2955)
+(0.0060 -0.0255 0.2955)
+(-0.0060 -0.0225 0.2955)
+(-0.0030 -0.0225 0.2955)
+(0.0000 -0.0225 0.2955)
+(0.0030 -0.0225 0.2955)
+(0.0060 -0.0225 0.2955)
+(-0.0060 -0.0195 0.2955)
+(-0.0030 -0.0195 0.2955)
+(0.0000 -0.0195 0.2955)
+(0.0030 -0.0195 0.2955)
+(0.0060 -0.0195 0.2955)
+(-0.0060 -0.0165 0.2955)
+(-0.0030 -0.0165 0.2955)
+(0.0000 -0.0165 0.2955)
+(0.0030 -0.0165 0.2955)
+(0.0060 -0.0165 0.2955)
+(-0.0060 -0.0135 0.2955)
+(-0.0030 -0.0135 0.2955)
+(0.0000 -0.0135 0.2955)
+(0.0030 -0.0135 0.2955)
+(0.0060 -0.0135 0.2955)
+(-0.0060 -0.0105 0.2955)
+(-0.0030 -0.0105 0.2955)
+(0.0000 -0.0105 0.2955)
+(0.0030 -0.0105 0.2955)
+(0.0060 -0.0105 0.2955)
+(-0.0060 -0.0075 0.2955)
+(-0.0030 -0.0075 0.2955)
+(0.0000 -0.0075 0.2955)
+(0.0030 -0.0075 0.2955)
+(0.0060 -0.0075 0.2955)
+(-0.0060 -0.0045 0.2955)
+(-0.0030 -0.0045 0.2955)
+(0.0000 -0.0045 0.2955)
+(0.0030 -0.0045 0.2955)
+(0.0060 -0.0045 0.2955)
+(-0.0060 -0.0015 0.2955)
+(-0.0030 -0.0015 0.2955)
+(0.0000 -0.0015 0.2955)
+(0.0030 -0.0015 0.2955)
+(0.0060 -0.0015 0.2955)
+(-0.0060 0.0015 0.2955)
+(-0.0030 0.0015 0.2955)
+(0.0000 0.0015 0.2955)
+(0.0030 0.0015 0.2955)
+(0.0060 0.0015 0.2955)
+(-0.0060 0.0045 0.2955)
+(-0.0030 0.0045 0.2955)
+(0.0000 0.0045 0.2955)
+(0.0030 0.0045 0.2955)
+(0.0060 0.0045 0.2955)
+(-0.0060 0.0075 0.2955)
+(-0.0030 0.0075 0.2955)
+(0.0000 0.0075 0.2955)
+(0.0030 0.0075 0.2955)
+(0.0060 0.0075 0.2955)
+(-0.0060 0.0105 0.2955)
+(-0.0030 0.0105 0.2955)
+(0.0000 0.0105 0.2955)
+(0.0030 0.0105 0.2955)
+(0.0060 0.0105 0.2955)
+(-0.0060 0.0135 0.2955)
+(-0.0030 0.0135 0.2955)
+(0.0000 0.0135 0.2955)
+(0.0030 0.0135 0.2955)
+(0.0060 0.0135 0.2955)
+(-0.0060 0.0165 0.2955)
+(-0.0030 0.0165 0.2955)
+(0.0000 0.0165 0.2955)
+(0.0030 0.0165 0.2955)
+(0.0060 0.0165 0.2955)
+(-0.0060 0.0195 0.2955)
+(-0.0030 0.0195 0.2955)
+(0.0000 0.0195 0.2955)
+(0.0030 0.0195 0.2955)
+(0.0060 0.0195 0.2955)
+(-0.0060 0.0225 0.2955)
+(-0.0030 0.0225 0.2955)
+(0.0000 0.0225 0.2955)
+(0.0030 0.0225 0.2955)
+(0.0060 0.0225 0.2955)
+(-0.0060 0.0255 0.2955)
+(-0.0030 0.0255 0.2955)
+(0.0000 0.0255 0.2955)
+(0.0030 0.0255 0.2955)
+(0.0060 0.0255 0.2955)
+(-0.0060 0.0285 0.2955)
+(-0.0030 0.0285 0.2955)
+(0.0000 0.0285 0.2955)
+(0.0030 0.0285 0.2955)
+(0.0060 0.0285 0.2955)
+(-0.0060 0.0315 0.2955)
+(-0.0030 0.0315 0.2955)
+(0.0000 0.0315 0.2955)
+(0.0030 0.0315 0.2955)
+(0.0060 0.0315 0.2955)
+(-0.0060 0.0345 0.2955)
+(-0.0030 0.0345 0.2955)
+(0.0000 0.0345 0.2955)
+(0.0030 0.0345 0.2955)
+(0.0060 0.0345 0.2955)
+(-0.0060 0.0375 0.2955)
+(-0.0030 0.0375 0.2955)
+(0.0000 0.0375 0.2955)
+(0.0030 0.0375 0.2955)
+(0.0060 0.0375 0.2955)
+(-0.0060 0.0405 0.2955)
+(-0.0030 0.0405 0.2955)
+(0.0000 0.0405 0.2955)
+(0.0030 0.0405 0.2955)
+(0.0060 0.0405 0.2955)
+(-0.0060 0.0435 0.2955)
+(-0.0030 0.0435 0.2955)
+(0.0000 0.0435 0.2955)
+(0.0030 0.0435 0.2955)
+(0.0060 0.0435 0.2955)
+(-0.0060 0.0465 0.2955)
+(-0.0030 0.0465 0.2955)
+(0.0000 0.0465 0.2955)
+(0.0030 0.0465 0.2955)
+(0.0060 0.0465 0.2955)
+(-0.0060 0.0495 0.2955)
+(-0.0030 0.0495 0.2955)
+(0.0000 0.0495 0.2955)
+(0.0030 0.0495 0.2955)
+(0.0060 0.0495 0.2955)
+(-0.0060 0.0525 0.2955)
+(-0.0030 0.0525 0.2955)
+(0.0000 0.0525 0.2955)
+(0.0030 0.0525 0.2955)
+(0.0060 0.0525 0.2955)
+(-0.0060 0.0555 0.2955)
+(-0.0030 0.0555 0.2955)
+(0.0000 0.0555 0.2955)
+(0.0030 0.0555 0.2955)
+(0.0060 0.0555 0.2955)
+(-0.0060 0.0585 0.2955)
+(-0.0030 0.0585 0.2955)
+(0.0000 0.0585 0.2955)
+(0.0030 0.0585 0.2955)
+(0.0060 0.0585 0.2955)
+(-0.0060 0.0615 0.2955)
+(-0.0030 0.0615 0.2955)
+(0.0000 0.0615 0.2955)
+(0.0030 0.0615 0.2955)
+(0.0060 0.0615 0.2955)
+(-0.0060 0.0645 0.2955)
+(-0.0030 0.0645 0.2955)
+(0.0000 0.0645 0.2955)
+(0.0030 0.0645 0.2955)
+(0.0060 0.0645 0.2955)
+(-0.0060 0.0675 0.2955)
+(-0.0030 0.0675 0.2955)
+(0.0000 0.0675 0.2955)
+(0.0030 0.0675 0.2955)
+(0.0060 0.0675 0.2955)
+(-0.0060 0.0705 0.2955)
+(-0.0030 0.0705 0.2955)
+(0.0000 0.0705 0.2955)
+(0.0030 0.0705 0.2955)
+(0.0060 0.0705 0.2955)
+(-0.0060 0.0735 0.2955)
+(-0.0030 0.0735 0.2955)
+(0.0000 0.0735 0.2955)
+(0.0030 0.0735 0.2955)
+(0.0060 0.0735 0.2955)
+)
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/kinematicCloudProperties b/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/kinematicCloudProperties
new file mode 100644
index 0000000000000000000000000000000000000000..7aada1eb9208b8a4fb29a27817f139bf9917d2f8
--- /dev/null
+++ b/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/kinematicCloudProperties
@@ -0,0 +1,188 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                 |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      particleProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+solution
+{
+    active          true;
+    coupled         true;
+    transient       yes;
+    cellValueSourceCorrection off;
+
+    interpolationSchemes
+    {
+        rho.air         cell;
+        U.air           cellPoint;
+        mu.air          cell;
+    }
+
+    integrationSchemes
+    {
+        U               Euler;
+    }
+
+    sourceTerms
+    {
+        schemes
+        {
+            U semiImplicit 1;
+        }
+    }
+}
+
+constantProperties
+{
+    parcelTypeId 1;
+
+    rhoMin          1e-15;
+    minParticleMass 1e-15;
+
+    rho0            2526;
+    youngsModulus   1e8;
+    poissonsRatio   0.35;
+
+    constantVolume  false;
+
+    alphaMax        0.99;
+}
+
+subModels
+{
+    particleForces
+    {
+        ErgunWenYuDrag
+        {
+            alphac alpha.air;
+        }
+        gravity;
+    }
+
+    injectionModels
+    {
+        model1
+        {
+            type            manualInjection;
+            massTotal       0;
+            parcelBasisType fixed;
+            nParticle       1;
+            SOI             0;
+            positionsFile   "kinematicCloudPositions";
+            U0              ( 0 0 0 );
+            sizeDistribution
+            {
+                type        fixedValue;
+                fixedValueDistribution
+                {
+                    value   0.0025;
+                }
+            }
+        }
+    }
+
+    dispersionModel none;
+
+    patchInteractionModel localInteraction;
+
+    localInteractionCoeffs
+    {
+        patches
+        (
+            top
+            {
+                type rebound;
+                e    0.97;
+                mu   0.09;
+            }
+            bottom
+            {
+                type rebound;
+                e    0.97;
+                mu   0.09;
+            }
+            walls
+            {
+                type rebound;
+                e    0.97;
+                mu   0.09;
+            }
+            frontAndBack
+            {
+                type rebound;
+                e    0.97;
+                mu   0.09;
+            }
+        );
+    }
+
+    StandardWallInteractionCoeffs
+    {
+        type rebound;
+        e    0.97;
+        mu   0.09;
+    }
+
+    heatTransferModel none;
+
+    surfaceFilmModel none;
+
+    collisionModel pairCollision;
+
+    pairCollisionCoeffs
+    {
+        maxInteractionDistance  0.0025;
+
+        writeReferredParticleCloud no;
+
+        pairModel pairSpringSliderDashpot;
+
+        pairSpringSliderDashpotCoeffs
+        {
+            useEquivalentSize   no;
+            alpha               0.02;
+            b                   1.5;
+            mu                  0.10;
+            cohesionEnergyDensity 0;
+            collisionResolutionSteps 12;
+        };
+
+        wallModel wallSpringSliderDashpot;
+
+        wallSpringSliderDashpotCoeffs
+        {
+            useEquivalentSize no;
+            collisionResolutionSteps 12;
+            youngsModulus   1e8;
+            poissonsRatio   0.23;
+            alpha           0.01;
+            b               1.5;
+            mu              0.09;
+            cohesionEnergyDensity 0;
+        };
+
+        UName U.air;
+    }
+
+    stochasticCollisionModel none;
+
+    radiation off;
+}
+
+
+cloudFunctions
+{}
+
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/polyMesh/blockMeshDict b/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/polyMesh/blockMeshDict
new file mode 100644
index 0000000000000000000000000000000000000000..e88f0f3211ddf83b600dca4e236d5d1ba614141b
--- /dev/null
+++ b/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/polyMesh/blockMeshDict
@@ -0,0 +1,82 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                 |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    object      blockMeshDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+convertToMeters 0.001;
+
+vertices
+(
+    (-7.5 -75   0)
+    ( 7.5 -75   0)
+    ( 7.5  75   0)
+    (-7.5  75   0)
+    (-7.5 -75 450)
+    ( 7.5 -75 450)
+    ( 7.5  75 450)
+    (-7.5  75 450)
+);
+
+blocks
+(
+    //hex (0 1 2 3 4 5 6 7) (1 15 45) simpleGrading (1 1 1)
+    hex (0 1 2 3 4 5 6 7) (2 30 90) simpleGrading (1 1 1)
+);
+
+edges
+(
+);
+
+boundary
+(
+    top
+    {
+        type wall;
+        faces
+        (
+            (4 5 6 7)
+        );
+    }
+
+    bottom
+    {
+        type wall;
+        faces
+        (
+            (0 1 2 3)
+        );
+    }
+
+    walls
+    {
+        type wall;
+        faces
+        (
+            (0 1 5 4)
+            (2 3 7 6)
+        );
+    }
+
+    frontAndBack
+    {
+        type symmetry;
+        faces
+        (
+            (1 2 6 5)
+            (3 0 4 7)
+        );
+    }
+);
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/transportProperties b/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/transportProperties
new file mode 100644
index 0000000000000000000000000000000000000000..4d91af2fb3827a82afbf628abd3db0b9332d2183
--- /dev/null
+++ b/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/transportProperties
@@ -0,0 +1,25 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      transportProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+contiuousPhaseName air;
+
+rho.air         1.2;
+
+transportModel  Newtonian;
+nu              1e-05;
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/turbulenceProperties.air b/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/turbulenceProperties.air
new file mode 100644
index 0000000000000000000000000000000000000000..1296429b72a21953def920b08774aa75e1d048b1
--- /dev/null
+++ b/tutorials/lagrangian/DPMFoam/Goldschmidt/constant/turbulenceProperties.air
@@ -0,0 +1,20 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      turbulenceProperties.air;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+simulationType  laminar;
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/DPMFoam/Goldschmidt/system/controlDict b/tutorials/lagrangian/DPMFoam/Goldschmidt/system/controlDict
new file mode 100644
index 0000000000000000000000000000000000000000..1b35ecda46b34c53c915dfe89c46b2b0c57cca6c
--- /dev/null
+++ b/tutorials/lagrangian/DPMFoam/Goldschmidt/system/controlDict
@@ -0,0 +1,48 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                 |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "system";
+    object      controlDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+application     DPMFoam;
+
+startFrom       latestTime;
+
+startTime       0;
+
+stopAt          endTime;
+
+endTime         10;
+
+deltaT          2e-5;
+
+writeControl    runTime;
+
+writeInterval   0.01;
+
+purgeWrite      0;
+
+writeFormat     binary;
+
+writePrecision  6;
+
+writeCompression uncompressed;
+
+timeFormat      general;
+
+timePrecision   6;
+
+runTimeModifiable yes;
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/DPMFoam/Goldschmidt/system/decomposeParDict b/tutorials/lagrangian/DPMFoam/Goldschmidt/system/decomposeParDict
new file mode 100644
index 0000000000000000000000000000000000000000..3c8fe5c873afd7dc98e209af3a7ac4c7933ca5d4
--- /dev/null
+++ b/tutorials/lagrangian/DPMFoam/Goldschmidt/system/decomposeParDict
@@ -0,0 +1,28 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                 |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "system";
+    object      decomposeParDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+numberOfSubdomains 6;
+
+method          simple;
+
+simpleCoeffs
+{
+    n               ( 1 6 1 );
+    delta           0.001;
+}
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/DPMFoam/Goldschmidt/system/fvSchemes b/tutorials/lagrangian/DPMFoam/Goldschmidt/system/fvSchemes
new file mode 100644
index 0000000000000000000000000000000000000000..41c055ccbb9b7d146c2458d6de10c31f2c20093b
--- /dev/null
+++ b/tutorials/lagrangian/DPMFoam/Goldschmidt/system/fvSchemes
@@ -0,0 +1,57 @@
+/*--------------------------------*- 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      fvSchemes;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+ddtSchemes
+{
+    default Euler;
+}
+
+gradSchemes
+{
+    default         Gauss linear;
+}
+
+divSchemes
+{
+    default         none;
+
+    div(alphaPhic,U.air)    Gauss linearUpwindV unlimited;
+    div(((alpha.air*nuEff)*dev2(T(grad(U.air))))) Gauss linear;
+}
+
+laplacianSchemes
+{
+    default         Gauss linear corrected;
+}
+
+interpolationSchemes
+{
+    default         linear;
+}
+
+snGradSchemes
+{
+    default         corrected;
+}
+
+fluxRequired
+{
+    default         no;
+    p;
+    kinematicCloud:theta;
+}
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/DPMFoam/Goldschmidt/system/fvSolution b/tutorials/lagrangian/DPMFoam/Goldschmidt/system/fvSolution
new file mode 100644
index 0000000000000000000000000000000000000000..984e70bf6889d821db35aefabacd7e1049ff2bf8
--- /dev/null
+++ b/tutorials/lagrangian/DPMFoam/Goldschmidt/system/fvSolution
@@ -0,0 +1,76 @@
+/*--------------------------------*- 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|kinematicCloud:theta)"
+    {
+        solver          GAMG;
+        tolerance       1e-06;
+        relTol          0.01;
+        smoother        GaussSeidel;
+        cacheAgglomeration true;
+        nCellsInCoarsestLevel 10;
+        agglomerator    faceAreaPair;
+        mergeLevels     1;
+    }
+
+    "(p|kinematicCloud:theta)Final"
+    {
+        solver          GAMG;
+        tolerance       1e-06;
+        relTol          0;
+        smoother        GaussSeidel;
+        cacheAgglomeration true;
+        nCellsInCoarsestLevel 10;
+        agglomerator    faceAreaPair;
+        mergeLevels     1;
+    }
+
+    "(U.air|k|omega)"
+    {
+        solver          PBiCG;
+        preconditioner  DILU;
+        tolerance       1e-05;
+        relTol          0.1;
+    }
+
+    "(U.air|k|omega)Final"
+    {
+        solver          PBiCG;
+        preconditioner  DILU;
+        tolerance       1e-05;
+        relTol          0;
+    }
+}
+
+PIMPLE
+{
+    nOuterCorrectors 1;
+    nCorrectors     2;
+    momentumPredictor yes;
+    nNonOrthogonalCorrectors 0;
+    pRefCell        0;
+    pRefValue       0;
+}
+
+relaxationFactors
+{
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/DPMFoam/Goldschmidt/system/mapFieldsDict b/tutorials/lagrangian/DPMFoam/Goldschmidt/system/mapFieldsDict
new file mode 100644
index 0000000000000000000000000000000000000000..bb1a6eb6e36773d73b31c13d1a10fb477856374c
--- /dev/null
+++ b/tutorials/lagrangian/DPMFoam/Goldschmidt/system/mapFieldsDict
@@ -0,0 +1,29 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                 |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    object      mapFieldsDict;
+}
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+// List of pairs of source/target patches for mapping
+patchMap
+(
+);
+
+// List of target patches cutting the source domain (these need to be
+// handled specially e.g. interpolated from internal values)
+cuttingPatches
+(
+);
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/Goldschmidt/0/U.air b/tutorials/lagrangian/MPPICFoam/Goldschmidt/0/U.air
new file mode 100644
index 0000000000000000000000000000000000000000..486a026f8d2416e4b22fb9e2cc7b9aa3b69a4b76
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/Goldschmidt/0/U.air
@@ -0,0 +1,54 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      binary;
+    class       volVectorField;
+    location    "0";
+    object      U.air;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 1 -1 0 0 0 0];
+
+internalField   uniform (0 0 0);
+
+boundaryField
+{
+    walls
+    {
+        type            fixedValue;
+        value           uniform (0 0 0);
+    }
+
+    top
+    {
+        type            pressureInletOutletVelocity;
+        phi             phi.air;
+        inletValue      uniform (0 0 0);
+        value           uniform (0 0 0);
+    }
+
+    bottom
+    {
+        type            interstitialInletVelocity;
+        inletVelocity   uniform (0 0 1.875);
+        value           uniform (0 0 1.875);
+        phi             phi.air;
+        alpha           alpha.air;
+    }
+
+    frontAndBack
+    {
+        type            symmetry;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/Goldschmidt/0/p b/tutorials/lagrangian/MPPICFoam/Goldschmidt/0/p
new file mode 100644
index 0000000000000000000000000000000000000000..d4715eccd0983568890a1fa197a204ef1b345a27
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/Goldschmidt/0/p
@@ -0,0 +1,50 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       volScalarField;
+    object      p;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 2 -2 0 0 0 0];
+
+internalField   uniform 0;
+
+boundaryField
+{
+    walls
+    {
+        type            fixedFluxPressure;
+        phi             phi.air;
+        value           $internalField;
+    }
+
+    bottom
+    {
+        type            fixedFluxPressure;
+        phi             phi.air;
+        value           $internalField;
+    }
+
+    top
+    {
+        type            fixedValue;
+        phi             phi.air;
+        value           $internalField;
+    }
+
+    frontAndBack
+    {
+        type            symmetry;
+    }
+}
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/g b/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/g
new file mode 100644
index 0000000000000000000000000000000000000000..c80141a8bd5dedbd00908d5ae182afae759bdfaf
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/g
@@ -0,0 +1,21 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       uniformDimensionedVectorField;
+    location    "constant";
+    object      g;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 1 -2 0 0 0 0];
+value           ( 0 0 -9.81 );
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/kinematicCloudPositions b/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/kinematicCloudPositions
new file mode 100644
index 0000000000000000000000000000000000000000..d12dfd9cc7cf0195c31b60c95130d97e21a53f09
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/kinematicCloudPositions
@@ -0,0 +1,24770 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       vectorField;
+    object      kinematicCloudPositions;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+(
+(-0.0060 -0.0735 0.0015)
+(-0.0030 -0.0735 0.0015)
+(0.0000 -0.0735 0.0015)
+(0.0030 -0.0735 0.0015)
+(0.0060 -0.0735 0.0015)
+(-0.0060 -0.0705 0.0015)
+(-0.0030 -0.0705 0.0015)
+(0.0000 -0.0705 0.0015)
+(0.0030 -0.0705 0.0015)
+(0.0060 -0.0705 0.0015)
+(-0.0060 -0.0675 0.0015)
+(-0.0030 -0.0675 0.0015)
+(0.0000 -0.0675 0.0015)
+(0.0030 -0.0675 0.0015)
+(0.0060 -0.0675 0.0015)
+(-0.0060 -0.0645 0.0015)
+(-0.0030 -0.0645 0.0015)
+(0.0000 -0.0645 0.0015)
+(0.0030 -0.0645 0.0015)
+(0.0060 -0.0645 0.0015)
+(-0.0060 -0.0615 0.0015)
+(-0.0030 -0.0615 0.0015)
+(0.0000 -0.0615 0.0015)
+(0.0030 -0.0615 0.0015)
+(0.0060 -0.0615 0.0015)
+(-0.0060 -0.0585 0.0015)
+(-0.0030 -0.0585 0.0015)
+(0.0000 -0.0585 0.0015)
+(0.0030 -0.0585 0.0015)
+(0.0060 -0.0585 0.0015)
+(-0.0060 -0.0555 0.0015)
+(-0.0030 -0.0555 0.0015)
+(0.0000 -0.0555 0.0015)
+(0.0030 -0.0555 0.0015)
+(0.0060 -0.0555 0.0015)
+(-0.0060 -0.0525 0.0015)
+(-0.0030 -0.0525 0.0015)
+(0.0000 -0.0525 0.0015)
+(0.0030 -0.0525 0.0015)
+(0.0060 -0.0525 0.0015)
+(-0.0060 -0.0495 0.0015)
+(-0.0030 -0.0495 0.0015)
+(0.0000 -0.0495 0.0015)
+(0.0030 -0.0495 0.0015)
+(0.0060 -0.0495 0.0015)
+(-0.0060 -0.0465 0.0015)
+(-0.0030 -0.0465 0.0015)
+(0.0000 -0.0465 0.0015)
+(0.0030 -0.0465 0.0015)
+(0.0060 -0.0465 0.0015)
+(-0.0060 -0.0435 0.0015)
+(-0.0030 -0.0435 0.0015)
+(0.0000 -0.0435 0.0015)
+(0.0030 -0.0435 0.0015)
+(0.0060 -0.0435 0.0015)
+(-0.0060 -0.0405 0.0015)
+(-0.0030 -0.0405 0.0015)
+(0.0000 -0.0405 0.0015)
+(0.0030 -0.0405 0.0015)
+(0.0060 -0.0405 0.0015)
+(-0.0060 -0.0375 0.0015)
+(-0.0030 -0.0375 0.0015)
+(0.0000 -0.0375 0.0015)
+(0.0030 -0.0375 0.0015)
+(0.0060 -0.0375 0.0015)
+(-0.0060 -0.0345 0.0015)
+(-0.0030 -0.0345 0.0015)
+(0.0000 -0.0345 0.0015)
+(0.0030 -0.0345 0.0015)
+(0.0060 -0.0345 0.0015)
+(-0.0060 -0.0315 0.0015)
+(-0.0030 -0.0315 0.0015)
+(0.0000 -0.0315 0.0015)
+(0.0030 -0.0315 0.0015)
+(0.0060 -0.0315 0.0015)
+(-0.0060 -0.0285 0.0015)
+(-0.0030 -0.0285 0.0015)
+(0.0000 -0.0285 0.0015)
+(0.0030 -0.0285 0.0015)
+(0.0060 -0.0285 0.0015)
+(-0.0060 -0.0255 0.0015)
+(-0.0030 -0.0255 0.0015)
+(0.0000 -0.0255 0.0015)
+(0.0030 -0.0255 0.0015)
+(0.0060 -0.0255 0.0015)
+(-0.0060 -0.0225 0.0015)
+(-0.0030 -0.0225 0.0015)
+(0.0000 -0.0225 0.0015)
+(0.0030 -0.0225 0.0015)
+(0.0060 -0.0225 0.0015)
+(-0.0060 -0.0195 0.0015)
+(-0.0030 -0.0195 0.0015)
+(0.0000 -0.0195 0.0015)
+(0.0030 -0.0195 0.0015)
+(0.0060 -0.0195 0.0015)
+(-0.0060 -0.0165 0.0015)
+(-0.0030 -0.0165 0.0015)
+(0.0000 -0.0165 0.0015)
+(0.0030 -0.0165 0.0015)
+(0.0060 -0.0165 0.0015)
+(-0.0060 -0.0135 0.0015)
+(-0.0030 -0.0135 0.0015)
+(0.0000 -0.0135 0.0015)
+(0.0030 -0.0135 0.0015)
+(0.0060 -0.0135 0.0015)
+(-0.0060 -0.0105 0.0015)
+(-0.0030 -0.0105 0.0015)
+(0.0000 -0.0105 0.0015)
+(0.0030 -0.0105 0.0015)
+(0.0060 -0.0105 0.0015)
+(-0.0060 -0.0075 0.0015)
+(-0.0030 -0.0075 0.0015)
+(0.0000 -0.0075 0.0015)
+(0.0030 -0.0075 0.0015)
+(0.0060 -0.0075 0.0015)
+(-0.0060 -0.0045 0.0015)
+(-0.0030 -0.0045 0.0015)
+(0.0000 -0.0045 0.0015)
+(0.0030 -0.0045 0.0015)
+(0.0060 -0.0045 0.0015)
+(-0.0060 -0.0015 0.0015)
+(-0.0030 -0.0015 0.0015)
+(0.0000 -0.0015 0.0015)
+(0.0030 -0.0015 0.0015)
+(0.0060 -0.0015 0.0015)
+(-0.0060 0.0015 0.0015)
+(-0.0030 0.0015 0.0015)
+(0.0000 0.0015 0.0015)
+(0.0030 0.0015 0.0015)
+(0.0060 0.0015 0.0015)
+(-0.0060 0.0045 0.0015)
+(-0.0030 0.0045 0.0015)
+(0.0000 0.0045 0.0015)
+(0.0030 0.0045 0.0015)
+(0.0060 0.0045 0.0015)
+(-0.0060 0.0075 0.0015)
+(-0.0030 0.0075 0.0015)
+(0.0000 0.0075 0.0015)
+(0.0030 0.0075 0.0015)
+(0.0060 0.0075 0.0015)
+(-0.0060 0.0105 0.0015)
+(-0.0030 0.0105 0.0015)
+(0.0000 0.0105 0.0015)
+(0.0030 0.0105 0.0015)
+(0.0060 0.0105 0.0015)
+(-0.0060 0.0135 0.0015)
+(-0.0030 0.0135 0.0015)
+(0.0000 0.0135 0.0015)
+(0.0030 0.0135 0.0015)
+(0.0060 0.0135 0.0015)
+(-0.0060 0.0165 0.0015)
+(-0.0030 0.0165 0.0015)
+(0.0000 0.0165 0.0015)
+(0.0030 0.0165 0.0015)
+(0.0060 0.0165 0.0015)
+(-0.0060 0.0195 0.0015)
+(-0.0030 0.0195 0.0015)
+(0.0000 0.0195 0.0015)
+(0.0030 0.0195 0.0015)
+(0.0060 0.0195 0.0015)
+(-0.0060 0.0225 0.0015)
+(-0.0030 0.0225 0.0015)
+(0.0000 0.0225 0.0015)
+(0.0030 0.0225 0.0015)
+(0.0060 0.0225 0.0015)
+(-0.0060 0.0255 0.0015)
+(-0.0030 0.0255 0.0015)
+(0.0000 0.0255 0.0015)
+(0.0030 0.0255 0.0015)
+(0.0060 0.0255 0.0015)
+(-0.0060 0.0285 0.0015)
+(-0.0030 0.0285 0.0015)
+(0.0000 0.0285 0.0015)
+(0.0030 0.0285 0.0015)
+(0.0060 0.0285 0.0015)
+(-0.0060 0.0315 0.0015)
+(-0.0030 0.0315 0.0015)
+(0.0000 0.0315 0.0015)
+(0.0030 0.0315 0.0015)
+(0.0060 0.0315 0.0015)
+(-0.0060 0.0345 0.0015)
+(-0.0030 0.0345 0.0015)
+(0.0000 0.0345 0.0015)
+(0.0030 0.0345 0.0015)
+(0.0060 0.0345 0.0015)
+(-0.0060 0.0375 0.0015)
+(-0.0030 0.0375 0.0015)
+(0.0000 0.0375 0.0015)
+(0.0030 0.0375 0.0015)
+(0.0060 0.0375 0.0015)
+(-0.0060 0.0405 0.0015)
+(-0.0030 0.0405 0.0015)
+(0.0000 0.0405 0.0015)
+(0.0030 0.0405 0.0015)
+(0.0060 0.0405 0.0015)
+(-0.0060 0.0435 0.0015)
+(-0.0030 0.0435 0.0015)
+(0.0000 0.0435 0.0015)
+(0.0030 0.0435 0.0015)
+(0.0060 0.0435 0.0015)
+(-0.0060 0.0465 0.0015)
+(-0.0030 0.0465 0.0015)
+(0.0000 0.0465 0.0015)
+(0.0030 0.0465 0.0015)
+(0.0060 0.0465 0.0015)
+(-0.0060 0.0495 0.0015)
+(-0.0030 0.0495 0.0015)
+(0.0000 0.0495 0.0015)
+(0.0030 0.0495 0.0015)
+(0.0060 0.0495 0.0015)
+(-0.0060 0.0525 0.0015)
+(-0.0030 0.0525 0.0015)
+(0.0000 0.0525 0.0015)
+(0.0030 0.0525 0.0015)
+(0.0060 0.0525 0.0015)
+(-0.0060 0.0555 0.0015)
+(-0.0030 0.0555 0.0015)
+(0.0000 0.0555 0.0015)
+(0.0030 0.0555 0.0015)
+(0.0060 0.0555 0.0015)
+(-0.0060 0.0585 0.0015)
+(-0.0030 0.0585 0.0015)
+(0.0000 0.0585 0.0015)
+(0.0030 0.0585 0.0015)
+(0.0060 0.0585 0.0015)
+(-0.0060 0.0615 0.0015)
+(-0.0030 0.0615 0.0015)
+(0.0000 0.0615 0.0015)
+(0.0030 0.0615 0.0015)
+(0.0060 0.0615 0.0015)
+(-0.0060 0.0645 0.0015)
+(-0.0030 0.0645 0.0015)
+(0.0000 0.0645 0.0015)
+(0.0030 0.0645 0.0015)
+(0.0060 0.0645 0.0015)
+(-0.0060 0.0675 0.0015)
+(-0.0030 0.0675 0.0015)
+(0.0000 0.0675 0.0015)
+(0.0030 0.0675 0.0015)
+(0.0060 0.0675 0.0015)
+(-0.0060 0.0705 0.0015)
+(-0.0030 0.0705 0.0015)
+(0.0000 0.0705 0.0015)
+(0.0030 0.0705 0.0015)
+(0.0060 0.0705 0.0015)
+(-0.0060 0.0735 0.0015)
+(-0.0030 0.0735 0.0015)
+(0.0000 0.0735 0.0015)
+(0.0030 0.0735 0.0015)
+(0.0060 0.0735 0.0015)
+(-0.0060 -0.0735 0.0045)
+(-0.0030 -0.0735 0.0045)
+(0.0000 -0.0735 0.0045)
+(0.0030 -0.0735 0.0045)
+(0.0060 -0.0735 0.0045)
+(-0.0060 -0.0705 0.0045)
+(-0.0030 -0.0705 0.0045)
+(0.0000 -0.0705 0.0045)
+(0.0030 -0.0705 0.0045)
+(0.0060 -0.0705 0.0045)
+(-0.0060 -0.0675 0.0045)
+(-0.0030 -0.0675 0.0045)
+(0.0000 -0.0675 0.0045)
+(0.0030 -0.0675 0.0045)
+(0.0060 -0.0675 0.0045)
+(-0.0060 -0.0645 0.0045)
+(-0.0030 -0.0645 0.0045)
+(0.0000 -0.0645 0.0045)
+(0.0030 -0.0645 0.0045)
+(0.0060 -0.0645 0.0045)
+(-0.0060 -0.0615 0.0045)
+(-0.0030 -0.0615 0.0045)
+(0.0000 -0.0615 0.0045)
+(0.0030 -0.0615 0.0045)
+(0.0060 -0.0615 0.0045)
+(-0.0060 -0.0585 0.0045)
+(-0.0030 -0.0585 0.0045)
+(0.0000 -0.0585 0.0045)
+(0.0030 -0.0585 0.0045)
+(0.0060 -0.0585 0.0045)
+(-0.0060 -0.0555 0.0045)
+(-0.0030 -0.0555 0.0045)
+(0.0000 -0.0555 0.0045)
+(0.0030 -0.0555 0.0045)
+(0.0060 -0.0555 0.0045)
+(-0.0060 -0.0525 0.0045)
+(-0.0030 -0.0525 0.0045)
+(0.0000 -0.0525 0.0045)
+(0.0030 -0.0525 0.0045)
+(0.0060 -0.0525 0.0045)
+(-0.0060 -0.0495 0.0045)
+(-0.0030 -0.0495 0.0045)
+(0.0000 -0.0495 0.0045)
+(0.0030 -0.0495 0.0045)
+(0.0060 -0.0495 0.0045)
+(-0.0060 -0.0465 0.0045)
+(-0.0030 -0.0465 0.0045)
+(0.0000 -0.0465 0.0045)
+(0.0030 -0.0465 0.0045)
+(0.0060 -0.0465 0.0045)
+(-0.0060 -0.0435 0.0045)
+(-0.0030 -0.0435 0.0045)
+(0.0000 -0.0435 0.0045)
+(0.0030 -0.0435 0.0045)
+(0.0060 -0.0435 0.0045)
+(-0.0060 -0.0405 0.0045)
+(-0.0030 -0.0405 0.0045)
+(0.0000 -0.0405 0.0045)
+(0.0030 -0.0405 0.0045)
+(0.0060 -0.0405 0.0045)
+(-0.0060 -0.0375 0.0045)
+(-0.0030 -0.0375 0.0045)
+(0.0000 -0.0375 0.0045)
+(0.0030 -0.0375 0.0045)
+(0.0060 -0.0375 0.0045)
+(-0.0060 -0.0345 0.0045)
+(-0.0030 -0.0345 0.0045)
+(0.0000 -0.0345 0.0045)
+(0.0030 -0.0345 0.0045)
+(0.0060 -0.0345 0.0045)
+(-0.0060 -0.0315 0.0045)
+(-0.0030 -0.0315 0.0045)
+(0.0000 -0.0315 0.0045)
+(0.0030 -0.0315 0.0045)
+(0.0060 -0.0315 0.0045)
+(-0.0060 -0.0285 0.0045)
+(-0.0030 -0.0285 0.0045)
+(0.0000 -0.0285 0.0045)
+(0.0030 -0.0285 0.0045)
+(0.0060 -0.0285 0.0045)
+(-0.0060 -0.0255 0.0045)
+(-0.0030 -0.0255 0.0045)
+(0.0000 -0.0255 0.0045)
+(0.0030 -0.0255 0.0045)
+(0.0060 -0.0255 0.0045)
+(-0.0060 -0.0225 0.0045)
+(-0.0030 -0.0225 0.0045)
+(0.0000 -0.0225 0.0045)
+(0.0030 -0.0225 0.0045)
+(0.0060 -0.0225 0.0045)
+(-0.0060 -0.0195 0.0045)
+(-0.0030 -0.0195 0.0045)
+(0.0000 -0.0195 0.0045)
+(0.0030 -0.0195 0.0045)
+(0.0060 -0.0195 0.0045)
+(-0.0060 -0.0165 0.0045)
+(-0.0030 -0.0165 0.0045)
+(0.0000 -0.0165 0.0045)
+(0.0030 -0.0165 0.0045)
+(0.0060 -0.0165 0.0045)
+(-0.0060 -0.0135 0.0045)
+(-0.0030 -0.0135 0.0045)
+(0.0000 -0.0135 0.0045)
+(0.0030 -0.0135 0.0045)
+(0.0060 -0.0135 0.0045)
+(-0.0060 -0.0105 0.0045)
+(-0.0030 -0.0105 0.0045)
+(0.0000 -0.0105 0.0045)
+(0.0030 -0.0105 0.0045)
+(0.0060 -0.0105 0.0045)
+(-0.0060 -0.0075 0.0045)
+(-0.0030 -0.0075 0.0045)
+(0.0000 -0.0075 0.0045)
+(0.0030 -0.0075 0.0045)
+(0.0060 -0.0075 0.0045)
+(-0.0060 -0.0045 0.0045)
+(-0.0030 -0.0045 0.0045)
+(0.0000 -0.0045 0.0045)
+(0.0030 -0.0045 0.0045)
+(0.0060 -0.0045 0.0045)
+(-0.0060 -0.0015 0.0045)
+(-0.0030 -0.0015 0.0045)
+(0.0000 -0.0015 0.0045)
+(0.0030 -0.0015 0.0045)
+(0.0060 -0.0015 0.0045)
+(-0.0060 0.0015 0.0045)
+(-0.0030 0.0015 0.0045)
+(0.0000 0.0015 0.0045)
+(0.0030 0.0015 0.0045)
+(0.0060 0.0015 0.0045)
+(-0.0060 0.0045 0.0045)
+(-0.0030 0.0045 0.0045)
+(0.0000 0.0045 0.0045)
+(0.0030 0.0045 0.0045)
+(0.0060 0.0045 0.0045)
+(-0.0060 0.0075 0.0045)
+(-0.0030 0.0075 0.0045)
+(0.0000 0.0075 0.0045)
+(0.0030 0.0075 0.0045)
+(0.0060 0.0075 0.0045)
+(-0.0060 0.0105 0.0045)
+(-0.0030 0.0105 0.0045)
+(0.0000 0.0105 0.0045)
+(0.0030 0.0105 0.0045)
+(0.0060 0.0105 0.0045)
+(-0.0060 0.0135 0.0045)
+(-0.0030 0.0135 0.0045)
+(0.0000 0.0135 0.0045)
+(0.0030 0.0135 0.0045)
+(0.0060 0.0135 0.0045)
+(-0.0060 0.0165 0.0045)
+(-0.0030 0.0165 0.0045)
+(0.0000 0.0165 0.0045)
+(0.0030 0.0165 0.0045)
+(0.0060 0.0165 0.0045)
+(-0.0060 0.0195 0.0045)
+(-0.0030 0.0195 0.0045)
+(0.0000 0.0195 0.0045)
+(0.0030 0.0195 0.0045)
+(0.0060 0.0195 0.0045)
+(-0.0060 0.0225 0.0045)
+(-0.0030 0.0225 0.0045)
+(0.0000 0.0225 0.0045)
+(0.0030 0.0225 0.0045)
+(0.0060 0.0225 0.0045)
+(-0.0060 0.0255 0.0045)
+(-0.0030 0.0255 0.0045)
+(0.0000 0.0255 0.0045)
+(0.0030 0.0255 0.0045)
+(0.0060 0.0255 0.0045)
+(-0.0060 0.0285 0.0045)
+(-0.0030 0.0285 0.0045)
+(0.0000 0.0285 0.0045)
+(0.0030 0.0285 0.0045)
+(0.0060 0.0285 0.0045)
+(-0.0060 0.0315 0.0045)
+(-0.0030 0.0315 0.0045)
+(0.0000 0.0315 0.0045)
+(0.0030 0.0315 0.0045)
+(0.0060 0.0315 0.0045)
+(-0.0060 0.0345 0.0045)
+(-0.0030 0.0345 0.0045)
+(0.0000 0.0345 0.0045)
+(0.0030 0.0345 0.0045)
+(0.0060 0.0345 0.0045)
+(-0.0060 0.0375 0.0045)
+(-0.0030 0.0375 0.0045)
+(0.0000 0.0375 0.0045)
+(0.0030 0.0375 0.0045)
+(0.0060 0.0375 0.0045)
+(-0.0060 0.0405 0.0045)
+(-0.0030 0.0405 0.0045)
+(0.0000 0.0405 0.0045)
+(0.0030 0.0405 0.0045)
+(0.0060 0.0405 0.0045)
+(-0.0060 0.0435 0.0045)
+(-0.0030 0.0435 0.0045)
+(0.0000 0.0435 0.0045)
+(0.0030 0.0435 0.0045)
+(0.0060 0.0435 0.0045)
+(-0.0060 0.0465 0.0045)
+(-0.0030 0.0465 0.0045)
+(0.0000 0.0465 0.0045)
+(0.0030 0.0465 0.0045)
+(0.0060 0.0465 0.0045)
+(-0.0060 0.0495 0.0045)
+(-0.0030 0.0495 0.0045)
+(0.0000 0.0495 0.0045)
+(0.0030 0.0495 0.0045)
+(0.0060 0.0495 0.0045)
+(-0.0060 0.0525 0.0045)
+(-0.0030 0.0525 0.0045)
+(0.0000 0.0525 0.0045)
+(0.0030 0.0525 0.0045)
+(0.0060 0.0525 0.0045)
+(-0.0060 0.0555 0.0045)
+(-0.0030 0.0555 0.0045)
+(0.0000 0.0555 0.0045)
+(0.0030 0.0555 0.0045)
+(0.0060 0.0555 0.0045)
+(-0.0060 0.0585 0.0045)
+(-0.0030 0.0585 0.0045)
+(0.0000 0.0585 0.0045)
+(0.0030 0.0585 0.0045)
+(0.0060 0.0585 0.0045)
+(-0.0060 0.0615 0.0045)
+(-0.0030 0.0615 0.0045)
+(0.0000 0.0615 0.0045)
+(0.0030 0.0615 0.0045)
+(0.0060 0.0615 0.0045)
+(-0.0060 0.0645 0.0045)
+(-0.0030 0.0645 0.0045)
+(0.0000 0.0645 0.0045)
+(0.0030 0.0645 0.0045)
+(0.0060 0.0645 0.0045)
+(-0.0060 0.0675 0.0045)
+(-0.0030 0.0675 0.0045)
+(0.0000 0.0675 0.0045)
+(0.0030 0.0675 0.0045)
+(0.0060 0.0675 0.0045)
+(-0.0060 0.0705 0.0045)
+(-0.0030 0.0705 0.0045)
+(0.0000 0.0705 0.0045)
+(0.0030 0.0705 0.0045)
+(0.0060 0.0705 0.0045)
+(-0.0060 0.0735 0.0045)
+(-0.0030 0.0735 0.0045)
+(0.0000 0.0735 0.0045)
+(0.0030 0.0735 0.0045)
+(0.0060 0.0735 0.0045)
+(-0.0060 -0.0735 0.0075)
+(-0.0030 -0.0735 0.0075)
+(0.0000 -0.0735 0.0075)
+(0.0030 -0.0735 0.0075)
+(0.0060 -0.0735 0.0075)
+(-0.0060 -0.0705 0.0075)
+(-0.0030 -0.0705 0.0075)
+(0.0000 -0.0705 0.0075)
+(0.0030 -0.0705 0.0075)
+(0.0060 -0.0705 0.0075)
+(-0.0060 -0.0675 0.0075)
+(-0.0030 -0.0675 0.0075)
+(0.0000 -0.0675 0.0075)
+(0.0030 -0.0675 0.0075)
+(0.0060 -0.0675 0.0075)
+(-0.0060 -0.0645 0.0075)
+(-0.0030 -0.0645 0.0075)
+(0.0000 -0.0645 0.0075)
+(0.0030 -0.0645 0.0075)
+(0.0060 -0.0645 0.0075)
+(-0.0060 -0.0615 0.0075)
+(-0.0030 -0.0615 0.0075)
+(0.0000 -0.0615 0.0075)
+(0.0030 -0.0615 0.0075)
+(0.0060 -0.0615 0.0075)
+(-0.0060 -0.0585 0.0075)
+(-0.0030 -0.0585 0.0075)
+(0.0000 -0.0585 0.0075)
+(0.0030 -0.0585 0.0075)
+(0.0060 -0.0585 0.0075)
+(-0.0060 -0.0555 0.0075)
+(-0.0030 -0.0555 0.0075)
+(0.0000 -0.0555 0.0075)
+(0.0030 -0.0555 0.0075)
+(0.0060 -0.0555 0.0075)
+(-0.0060 -0.0525 0.0075)
+(-0.0030 -0.0525 0.0075)
+(0.0000 -0.0525 0.0075)
+(0.0030 -0.0525 0.0075)
+(0.0060 -0.0525 0.0075)
+(-0.0060 -0.0495 0.0075)
+(-0.0030 -0.0495 0.0075)
+(0.0000 -0.0495 0.0075)
+(0.0030 -0.0495 0.0075)
+(0.0060 -0.0495 0.0075)
+(-0.0060 -0.0465 0.0075)
+(-0.0030 -0.0465 0.0075)
+(0.0000 -0.0465 0.0075)
+(0.0030 -0.0465 0.0075)
+(0.0060 -0.0465 0.0075)
+(-0.0060 -0.0435 0.0075)
+(-0.0030 -0.0435 0.0075)
+(0.0000 -0.0435 0.0075)
+(0.0030 -0.0435 0.0075)
+(0.0060 -0.0435 0.0075)
+(-0.0060 -0.0405 0.0075)
+(-0.0030 -0.0405 0.0075)
+(0.0000 -0.0405 0.0075)
+(0.0030 -0.0405 0.0075)
+(0.0060 -0.0405 0.0075)
+(-0.0060 -0.0375 0.0075)
+(-0.0030 -0.0375 0.0075)
+(0.0000 -0.0375 0.0075)
+(0.0030 -0.0375 0.0075)
+(0.0060 -0.0375 0.0075)
+(-0.0060 -0.0345 0.0075)
+(-0.0030 -0.0345 0.0075)
+(0.0000 -0.0345 0.0075)
+(0.0030 -0.0345 0.0075)
+(0.0060 -0.0345 0.0075)
+(-0.0060 -0.0315 0.0075)
+(-0.0030 -0.0315 0.0075)
+(0.0000 -0.0315 0.0075)
+(0.0030 -0.0315 0.0075)
+(0.0060 -0.0315 0.0075)
+(-0.0060 -0.0285 0.0075)
+(-0.0030 -0.0285 0.0075)
+(0.0000 -0.0285 0.0075)
+(0.0030 -0.0285 0.0075)
+(0.0060 -0.0285 0.0075)
+(-0.0060 -0.0255 0.0075)
+(-0.0030 -0.0255 0.0075)
+(0.0000 -0.0255 0.0075)
+(0.0030 -0.0255 0.0075)
+(0.0060 -0.0255 0.0075)
+(-0.0060 -0.0225 0.0075)
+(-0.0030 -0.0225 0.0075)
+(0.0000 -0.0225 0.0075)
+(0.0030 -0.0225 0.0075)
+(0.0060 -0.0225 0.0075)
+(-0.0060 -0.0195 0.0075)
+(-0.0030 -0.0195 0.0075)
+(0.0000 -0.0195 0.0075)
+(0.0030 -0.0195 0.0075)
+(0.0060 -0.0195 0.0075)
+(-0.0060 -0.0165 0.0075)
+(-0.0030 -0.0165 0.0075)
+(0.0000 -0.0165 0.0075)
+(0.0030 -0.0165 0.0075)
+(0.0060 -0.0165 0.0075)
+(-0.0060 -0.0135 0.0075)
+(-0.0030 -0.0135 0.0075)
+(0.0000 -0.0135 0.0075)
+(0.0030 -0.0135 0.0075)
+(0.0060 -0.0135 0.0075)
+(-0.0060 -0.0105 0.0075)
+(-0.0030 -0.0105 0.0075)
+(0.0000 -0.0105 0.0075)
+(0.0030 -0.0105 0.0075)
+(0.0060 -0.0105 0.0075)
+(-0.0060 -0.0075 0.0075)
+(-0.0030 -0.0075 0.0075)
+(0.0000 -0.0075 0.0075)
+(0.0030 -0.0075 0.0075)
+(0.0060 -0.0075 0.0075)
+(-0.0060 -0.0045 0.0075)
+(-0.0030 -0.0045 0.0075)
+(0.0000 -0.0045 0.0075)
+(0.0030 -0.0045 0.0075)
+(0.0060 -0.0045 0.0075)
+(-0.0060 -0.0015 0.0075)
+(-0.0030 -0.0015 0.0075)
+(0.0000 -0.0015 0.0075)
+(0.0030 -0.0015 0.0075)
+(0.0060 -0.0015 0.0075)
+(-0.0060 0.0015 0.0075)
+(-0.0030 0.0015 0.0075)
+(0.0000 0.0015 0.0075)
+(0.0030 0.0015 0.0075)
+(0.0060 0.0015 0.0075)
+(-0.0060 0.0045 0.0075)
+(-0.0030 0.0045 0.0075)
+(0.0000 0.0045 0.0075)
+(0.0030 0.0045 0.0075)
+(0.0060 0.0045 0.0075)
+(-0.0060 0.0075 0.0075)
+(-0.0030 0.0075 0.0075)
+(0.0000 0.0075 0.0075)
+(0.0030 0.0075 0.0075)
+(0.0060 0.0075 0.0075)
+(-0.0060 0.0105 0.0075)
+(-0.0030 0.0105 0.0075)
+(0.0000 0.0105 0.0075)
+(0.0030 0.0105 0.0075)
+(0.0060 0.0105 0.0075)
+(-0.0060 0.0135 0.0075)
+(-0.0030 0.0135 0.0075)
+(0.0000 0.0135 0.0075)
+(0.0030 0.0135 0.0075)
+(0.0060 0.0135 0.0075)
+(-0.0060 0.0165 0.0075)
+(-0.0030 0.0165 0.0075)
+(0.0000 0.0165 0.0075)
+(0.0030 0.0165 0.0075)
+(0.0060 0.0165 0.0075)
+(-0.0060 0.0195 0.0075)
+(-0.0030 0.0195 0.0075)
+(0.0000 0.0195 0.0075)
+(0.0030 0.0195 0.0075)
+(0.0060 0.0195 0.0075)
+(-0.0060 0.0225 0.0075)
+(-0.0030 0.0225 0.0075)
+(0.0000 0.0225 0.0075)
+(0.0030 0.0225 0.0075)
+(0.0060 0.0225 0.0075)
+(-0.0060 0.0255 0.0075)
+(-0.0030 0.0255 0.0075)
+(0.0000 0.0255 0.0075)
+(0.0030 0.0255 0.0075)
+(0.0060 0.0255 0.0075)
+(-0.0060 0.0285 0.0075)
+(-0.0030 0.0285 0.0075)
+(0.0000 0.0285 0.0075)
+(0.0030 0.0285 0.0075)
+(0.0060 0.0285 0.0075)
+(-0.0060 0.0315 0.0075)
+(-0.0030 0.0315 0.0075)
+(0.0000 0.0315 0.0075)
+(0.0030 0.0315 0.0075)
+(0.0060 0.0315 0.0075)
+(-0.0060 0.0345 0.0075)
+(-0.0030 0.0345 0.0075)
+(0.0000 0.0345 0.0075)
+(0.0030 0.0345 0.0075)
+(0.0060 0.0345 0.0075)
+(-0.0060 0.0375 0.0075)
+(-0.0030 0.0375 0.0075)
+(0.0000 0.0375 0.0075)
+(0.0030 0.0375 0.0075)
+(0.0060 0.0375 0.0075)
+(-0.0060 0.0405 0.0075)
+(-0.0030 0.0405 0.0075)
+(0.0000 0.0405 0.0075)
+(0.0030 0.0405 0.0075)
+(0.0060 0.0405 0.0075)
+(-0.0060 0.0435 0.0075)
+(-0.0030 0.0435 0.0075)
+(0.0000 0.0435 0.0075)
+(0.0030 0.0435 0.0075)
+(0.0060 0.0435 0.0075)
+(-0.0060 0.0465 0.0075)
+(-0.0030 0.0465 0.0075)
+(0.0000 0.0465 0.0075)
+(0.0030 0.0465 0.0075)
+(0.0060 0.0465 0.0075)
+(-0.0060 0.0495 0.0075)
+(-0.0030 0.0495 0.0075)
+(0.0000 0.0495 0.0075)
+(0.0030 0.0495 0.0075)
+(0.0060 0.0495 0.0075)
+(-0.0060 0.0525 0.0075)
+(-0.0030 0.0525 0.0075)
+(0.0000 0.0525 0.0075)
+(0.0030 0.0525 0.0075)
+(0.0060 0.0525 0.0075)
+(-0.0060 0.0555 0.0075)
+(-0.0030 0.0555 0.0075)
+(0.0000 0.0555 0.0075)
+(0.0030 0.0555 0.0075)
+(0.0060 0.0555 0.0075)
+(-0.0060 0.0585 0.0075)
+(-0.0030 0.0585 0.0075)
+(0.0000 0.0585 0.0075)
+(0.0030 0.0585 0.0075)
+(0.0060 0.0585 0.0075)
+(-0.0060 0.0615 0.0075)
+(-0.0030 0.0615 0.0075)
+(0.0000 0.0615 0.0075)
+(0.0030 0.0615 0.0075)
+(0.0060 0.0615 0.0075)
+(-0.0060 0.0645 0.0075)
+(-0.0030 0.0645 0.0075)
+(0.0000 0.0645 0.0075)
+(0.0030 0.0645 0.0075)
+(0.0060 0.0645 0.0075)
+(-0.0060 0.0675 0.0075)
+(-0.0030 0.0675 0.0075)
+(0.0000 0.0675 0.0075)
+(0.0030 0.0675 0.0075)
+(0.0060 0.0675 0.0075)
+(-0.0060 0.0705 0.0075)
+(-0.0030 0.0705 0.0075)
+(0.0000 0.0705 0.0075)
+(0.0030 0.0705 0.0075)
+(0.0060 0.0705 0.0075)
+(-0.0060 0.0735 0.0075)
+(-0.0030 0.0735 0.0075)
+(0.0000 0.0735 0.0075)
+(0.0030 0.0735 0.0075)
+(0.0060 0.0735 0.0075)
+(-0.0060 -0.0735 0.0105)
+(-0.0030 -0.0735 0.0105)
+(0.0000 -0.0735 0.0105)
+(0.0030 -0.0735 0.0105)
+(0.0060 -0.0735 0.0105)
+(-0.0060 -0.0705 0.0105)
+(-0.0030 -0.0705 0.0105)
+(0.0000 -0.0705 0.0105)
+(0.0030 -0.0705 0.0105)
+(0.0060 -0.0705 0.0105)
+(-0.0060 -0.0675 0.0105)
+(-0.0030 -0.0675 0.0105)
+(0.0000 -0.0675 0.0105)
+(0.0030 -0.0675 0.0105)
+(0.0060 -0.0675 0.0105)
+(-0.0060 -0.0645 0.0105)
+(-0.0030 -0.0645 0.0105)
+(0.0000 -0.0645 0.0105)
+(0.0030 -0.0645 0.0105)
+(0.0060 -0.0645 0.0105)
+(-0.0060 -0.0615 0.0105)
+(-0.0030 -0.0615 0.0105)
+(0.0000 -0.0615 0.0105)
+(0.0030 -0.0615 0.0105)
+(0.0060 -0.0615 0.0105)
+(-0.0060 -0.0585 0.0105)
+(-0.0030 -0.0585 0.0105)
+(0.0000 -0.0585 0.0105)
+(0.0030 -0.0585 0.0105)
+(0.0060 -0.0585 0.0105)
+(-0.0060 -0.0555 0.0105)
+(-0.0030 -0.0555 0.0105)
+(0.0000 -0.0555 0.0105)
+(0.0030 -0.0555 0.0105)
+(0.0060 -0.0555 0.0105)
+(-0.0060 -0.0525 0.0105)
+(-0.0030 -0.0525 0.0105)
+(0.0000 -0.0525 0.0105)
+(0.0030 -0.0525 0.0105)
+(0.0060 -0.0525 0.0105)
+(-0.0060 -0.0495 0.0105)
+(-0.0030 -0.0495 0.0105)
+(0.0000 -0.0495 0.0105)
+(0.0030 -0.0495 0.0105)
+(0.0060 -0.0495 0.0105)
+(-0.0060 -0.0465 0.0105)
+(-0.0030 -0.0465 0.0105)
+(0.0000 -0.0465 0.0105)
+(0.0030 -0.0465 0.0105)
+(0.0060 -0.0465 0.0105)
+(-0.0060 -0.0435 0.0105)
+(-0.0030 -0.0435 0.0105)
+(0.0000 -0.0435 0.0105)
+(0.0030 -0.0435 0.0105)
+(0.0060 -0.0435 0.0105)
+(-0.0060 -0.0405 0.0105)
+(-0.0030 -0.0405 0.0105)
+(0.0000 -0.0405 0.0105)
+(0.0030 -0.0405 0.0105)
+(0.0060 -0.0405 0.0105)
+(-0.0060 -0.0375 0.0105)
+(-0.0030 -0.0375 0.0105)
+(0.0000 -0.0375 0.0105)
+(0.0030 -0.0375 0.0105)
+(0.0060 -0.0375 0.0105)
+(-0.0060 -0.0345 0.0105)
+(-0.0030 -0.0345 0.0105)
+(0.0000 -0.0345 0.0105)
+(0.0030 -0.0345 0.0105)
+(0.0060 -0.0345 0.0105)
+(-0.0060 -0.0315 0.0105)
+(-0.0030 -0.0315 0.0105)
+(0.0000 -0.0315 0.0105)
+(0.0030 -0.0315 0.0105)
+(0.0060 -0.0315 0.0105)
+(-0.0060 -0.0285 0.0105)
+(-0.0030 -0.0285 0.0105)
+(0.0000 -0.0285 0.0105)
+(0.0030 -0.0285 0.0105)
+(0.0060 -0.0285 0.0105)
+(-0.0060 -0.0255 0.0105)
+(-0.0030 -0.0255 0.0105)
+(0.0000 -0.0255 0.0105)
+(0.0030 -0.0255 0.0105)
+(0.0060 -0.0255 0.0105)
+(-0.0060 -0.0225 0.0105)
+(-0.0030 -0.0225 0.0105)
+(0.0000 -0.0225 0.0105)
+(0.0030 -0.0225 0.0105)
+(0.0060 -0.0225 0.0105)
+(-0.0060 -0.0195 0.0105)
+(-0.0030 -0.0195 0.0105)
+(0.0000 -0.0195 0.0105)
+(0.0030 -0.0195 0.0105)
+(0.0060 -0.0195 0.0105)
+(-0.0060 -0.0165 0.0105)
+(-0.0030 -0.0165 0.0105)
+(0.0000 -0.0165 0.0105)
+(0.0030 -0.0165 0.0105)
+(0.0060 -0.0165 0.0105)
+(-0.0060 -0.0135 0.0105)
+(-0.0030 -0.0135 0.0105)
+(0.0000 -0.0135 0.0105)
+(0.0030 -0.0135 0.0105)
+(0.0060 -0.0135 0.0105)
+(-0.0060 -0.0105 0.0105)
+(-0.0030 -0.0105 0.0105)
+(0.0000 -0.0105 0.0105)
+(0.0030 -0.0105 0.0105)
+(0.0060 -0.0105 0.0105)
+(-0.0060 -0.0075 0.0105)
+(-0.0030 -0.0075 0.0105)
+(0.0000 -0.0075 0.0105)
+(0.0030 -0.0075 0.0105)
+(0.0060 -0.0075 0.0105)
+(-0.0060 -0.0045 0.0105)
+(-0.0030 -0.0045 0.0105)
+(0.0000 -0.0045 0.0105)
+(0.0030 -0.0045 0.0105)
+(0.0060 -0.0045 0.0105)
+(-0.0060 -0.0015 0.0105)
+(-0.0030 -0.0015 0.0105)
+(0.0000 -0.0015 0.0105)
+(0.0030 -0.0015 0.0105)
+(0.0060 -0.0015 0.0105)
+(-0.0060 0.0015 0.0105)
+(-0.0030 0.0015 0.0105)
+(0.0000 0.0015 0.0105)
+(0.0030 0.0015 0.0105)
+(0.0060 0.0015 0.0105)
+(-0.0060 0.0045 0.0105)
+(-0.0030 0.0045 0.0105)
+(0.0000 0.0045 0.0105)
+(0.0030 0.0045 0.0105)
+(0.0060 0.0045 0.0105)
+(-0.0060 0.0075 0.0105)
+(-0.0030 0.0075 0.0105)
+(0.0000 0.0075 0.0105)
+(0.0030 0.0075 0.0105)
+(0.0060 0.0075 0.0105)
+(-0.0060 0.0105 0.0105)
+(-0.0030 0.0105 0.0105)
+(0.0000 0.0105 0.0105)
+(0.0030 0.0105 0.0105)
+(0.0060 0.0105 0.0105)
+(-0.0060 0.0135 0.0105)
+(-0.0030 0.0135 0.0105)
+(0.0000 0.0135 0.0105)
+(0.0030 0.0135 0.0105)
+(0.0060 0.0135 0.0105)
+(-0.0060 0.0165 0.0105)
+(-0.0030 0.0165 0.0105)
+(0.0000 0.0165 0.0105)
+(0.0030 0.0165 0.0105)
+(0.0060 0.0165 0.0105)
+(-0.0060 0.0195 0.0105)
+(-0.0030 0.0195 0.0105)
+(0.0000 0.0195 0.0105)
+(0.0030 0.0195 0.0105)
+(0.0060 0.0195 0.0105)
+(-0.0060 0.0225 0.0105)
+(-0.0030 0.0225 0.0105)
+(0.0000 0.0225 0.0105)
+(0.0030 0.0225 0.0105)
+(0.0060 0.0225 0.0105)
+(-0.0060 0.0255 0.0105)
+(-0.0030 0.0255 0.0105)
+(0.0000 0.0255 0.0105)
+(0.0030 0.0255 0.0105)
+(0.0060 0.0255 0.0105)
+(-0.0060 0.0285 0.0105)
+(-0.0030 0.0285 0.0105)
+(0.0000 0.0285 0.0105)
+(0.0030 0.0285 0.0105)
+(0.0060 0.0285 0.0105)
+(-0.0060 0.0315 0.0105)
+(-0.0030 0.0315 0.0105)
+(0.0000 0.0315 0.0105)
+(0.0030 0.0315 0.0105)
+(0.0060 0.0315 0.0105)
+(-0.0060 0.0345 0.0105)
+(-0.0030 0.0345 0.0105)
+(0.0000 0.0345 0.0105)
+(0.0030 0.0345 0.0105)
+(0.0060 0.0345 0.0105)
+(-0.0060 0.0375 0.0105)
+(-0.0030 0.0375 0.0105)
+(0.0000 0.0375 0.0105)
+(0.0030 0.0375 0.0105)
+(0.0060 0.0375 0.0105)
+(-0.0060 0.0405 0.0105)
+(-0.0030 0.0405 0.0105)
+(0.0000 0.0405 0.0105)
+(0.0030 0.0405 0.0105)
+(0.0060 0.0405 0.0105)
+(-0.0060 0.0435 0.0105)
+(-0.0030 0.0435 0.0105)
+(0.0000 0.0435 0.0105)
+(0.0030 0.0435 0.0105)
+(0.0060 0.0435 0.0105)
+(-0.0060 0.0465 0.0105)
+(-0.0030 0.0465 0.0105)
+(0.0000 0.0465 0.0105)
+(0.0030 0.0465 0.0105)
+(0.0060 0.0465 0.0105)
+(-0.0060 0.0495 0.0105)
+(-0.0030 0.0495 0.0105)
+(0.0000 0.0495 0.0105)
+(0.0030 0.0495 0.0105)
+(0.0060 0.0495 0.0105)
+(-0.0060 0.0525 0.0105)
+(-0.0030 0.0525 0.0105)
+(0.0000 0.0525 0.0105)
+(0.0030 0.0525 0.0105)
+(0.0060 0.0525 0.0105)
+(-0.0060 0.0555 0.0105)
+(-0.0030 0.0555 0.0105)
+(0.0000 0.0555 0.0105)
+(0.0030 0.0555 0.0105)
+(0.0060 0.0555 0.0105)
+(-0.0060 0.0585 0.0105)
+(-0.0030 0.0585 0.0105)
+(0.0000 0.0585 0.0105)
+(0.0030 0.0585 0.0105)
+(0.0060 0.0585 0.0105)
+(-0.0060 0.0615 0.0105)
+(-0.0030 0.0615 0.0105)
+(0.0000 0.0615 0.0105)
+(0.0030 0.0615 0.0105)
+(0.0060 0.0615 0.0105)
+(-0.0060 0.0645 0.0105)
+(-0.0030 0.0645 0.0105)
+(0.0000 0.0645 0.0105)
+(0.0030 0.0645 0.0105)
+(0.0060 0.0645 0.0105)
+(-0.0060 0.0675 0.0105)
+(-0.0030 0.0675 0.0105)
+(0.0000 0.0675 0.0105)
+(0.0030 0.0675 0.0105)
+(0.0060 0.0675 0.0105)
+(-0.0060 0.0705 0.0105)
+(-0.0030 0.0705 0.0105)
+(0.0000 0.0705 0.0105)
+(0.0030 0.0705 0.0105)
+(0.0060 0.0705 0.0105)
+(-0.0060 0.0735 0.0105)
+(-0.0030 0.0735 0.0105)
+(0.0000 0.0735 0.0105)
+(0.0030 0.0735 0.0105)
+(0.0060 0.0735 0.0105)
+(-0.0060 -0.0735 0.0135)
+(-0.0030 -0.0735 0.0135)
+(0.0000 -0.0735 0.0135)
+(0.0030 -0.0735 0.0135)
+(0.0060 -0.0735 0.0135)
+(-0.0060 -0.0705 0.0135)
+(-0.0030 -0.0705 0.0135)
+(0.0000 -0.0705 0.0135)
+(0.0030 -0.0705 0.0135)
+(0.0060 -0.0705 0.0135)
+(-0.0060 -0.0675 0.0135)
+(-0.0030 -0.0675 0.0135)
+(0.0000 -0.0675 0.0135)
+(0.0030 -0.0675 0.0135)
+(0.0060 -0.0675 0.0135)
+(-0.0060 -0.0645 0.0135)
+(-0.0030 -0.0645 0.0135)
+(0.0000 -0.0645 0.0135)
+(0.0030 -0.0645 0.0135)
+(0.0060 -0.0645 0.0135)
+(-0.0060 -0.0615 0.0135)
+(-0.0030 -0.0615 0.0135)
+(0.0000 -0.0615 0.0135)
+(0.0030 -0.0615 0.0135)
+(0.0060 -0.0615 0.0135)
+(-0.0060 -0.0585 0.0135)
+(-0.0030 -0.0585 0.0135)
+(0.0000 -0.0585 0.0135)
+(0.0030 -0.0585 0.0135)
+(0.0060 -0.0585 0.0135)
+(-0.0060 -0.0555 0.0135)
+(-0.0030 -0.0555 0.0135)
+(0.0000 -0.0555 0.0135)
+(0.0030 -0.0555 0.0135)
+(0.0060 -0.0555 0.0135)
+(-0.0060 -0.0525 0.0135)
+(-0.0030 -0.0525 0.0135)
+(0.0000 -0.0525 0.0135)
+(0.0030 -0.0525 0.0135)
+(0.0060 -0.0525 0.0135)
+(-0.0060 -0.0495 0.0135)
+(-0.0030 -0.0495 0.0135)
+(0.0000 -0.0495 0.0135)
+(0.0030 -0.0495 0.0135)
+(0.0060 -0.0495 0.0135)
+(-0.0060 -0.0465 0.0135)
+(-0.0030 -0.0465 0.0135)
+(0.0000 -0.0465 0.0135)
+(0.0030 -0.0465 0.0135)
+(0.0060 -0.0465 0.0135)
+(-0.0060 -0.0435 0.0135)
+(-0.0030 -0.0435 0.0135)
+(0.0000 -0.0435 0.0135)
+(0.0030 -0.0435 0.0135)
+(0.0060 -0.0435 0.0135)
+(-0.0060 -0.0405 0.0135)
+(-0.0030 -0.0405 0.0135)
+(0.0000 -0.0405 0.0135)
+(0.0030 -0.0405 0.0135)
+(0.0060 -0.0405 0.0135)
+(-0.0060 -0.0375 0.0135)
+(-0.0030 -0.0375 0.0135)
+(0.0000 -0.0375 0.0135)
+(0.0030 -0.0375 0.0135)
+(0.0060 -0.0375 0.0135)
+(-0.0060 -0.0345 0.0135)
+(-0.0030 -0.0345 0.0135)
+(0.0000 -0.0345 0.0135)
+(0.0030 -0.0345 0.0135)
+(0.0060 -0.0345 0.0135)
+(-0.0060 -0.0315 0.0135)
+(-0.0030 -0.0315 0.0135)
+(0.0000 -0.0315 0.0135)
+(0.0030 -0.0315 0.0135)
+(0.0060 -0.0315 0.0135)
+(-0.0060 -0.0285 0.0135)
+(-0.0030 -0.0285 0.0135)
+(0.0000 -0.0285 0.0135)
+(0.0030 -0.0285 0.0135)
+(0.0060 -0.0285 0.0135)
+(-0.0060 -0.0255 0.0135)
+(-0.0030 -0.0255 0.0135)
+(0.0000 -0.0255 0.0135)
+(0.0030 -0.0255 0.0135)
+(0.0060 -0.0255 0.0135)
+(-0.0060 -0.0225 0.0135)
+(-0.0030 -0.0225 0.0135)
+(0.0000 -0.0225 0.0135)
+(0.0030 -0.0225 0.0135)
+(0.0060 -0.0225 0.0135)
+(-0.0060 -0.0195 0.0135)
+(-0.0030 -0.0195 0.0135)
+(0.0000 -0.0195 0.0135)
+(0.0030 -0.0195 0.0135)
+(0.0060 -0.0195 0.0135)
+(-0.0060 -0.0165 0.0135)
+(-0.0030 -0.0165 0.0135)
+(0.0000 -0.0165 0.0135)
+(0.0030 -0.0165 0.0135)
+(0.0060 -0.0165 0.0135)
+(-0.0060 -0.0135 0.0135)
+(-0.0030 -0.0135 0.0135)
+(0.0000 -0.0135 0.0135)
+(0.0030 -0.0135 0.0135)
+(0.0060 -0.0135 0.0135)
+(-0.0060 -0.0105 0.0135)
+(-0.0030 -0.0105 0.0135)
+(0.0000 -0.0105 0.0135)
+(0.0030 -0.0105 0.0135)
+(0.0060 -0.0105 0.0135)
+(-0.0060 -0.0075 0.0135)
+(-0.0030 -0.0075 0.0135)
+(0.0000 -0.0075 0.0135)
+(0.0030 -0.0075 0.0135)
+(0.0060 -0.0075 0.0135)
+(-0.0060 -0.0045 0.0135)
+(-0.0030 -0.0045 0.0135)
+(0.0000 -0.0045 0.0135)
+(0.0030 -0.0045 0.0135)
+(0.0060 -0.0045 0.0135)
+(-0.0060 -0.0015 0.0135)
+(-0.0030 -0.0015 0.0135)
+(0.0000 -0.0015 0.0135)
+(0.0030 -0.0015 0.0135)
+(0.0060 -0.0015 0.0135)
+(-0.0060 0.0015 0.0135)
+(-0.0030 0.0015 0.0135)
+(0.0000 0.0015 0.0135)
+(0.0030 0.0015 0.0135)
+(0.0060 0.0015 0.0135)
+(-0.0060 0.0045 0.0135)
+(-0.0030 0.0045 0.0135)
+(0.0000 0.0045 0.0135)
+(0.0030 0.0045 0.0135)
+(0.0060 0.0045 0.0135)
+(-0.0060 0.0075 0.0135)
+(-0.0030 0.0075 0.0135)
+(0.0000 0.0075 0.0135)
+(0.0030 0.0075 0.0135)
+(0.0060 0.0075 0.0135)
+(-0.0060 0.0105 0.0135)
+(-0.0030 0.0105 0.0135)
+(0.0000 0.0105 0.0135)
+(0.0030 0.0105 0.0135)
+(0.0060 0.0105 0.0135)
+(-0.0060 0.0135 0.0135)
+(-0.0030 0.0135 0.0135)
+(0.0000 0.0135 0.0135)
+(0.0030 0.0135 0.0135)
+(0.0060 0.0135 0.0135)
+(-0.0060 0.0165 0.0135)
+(-0.0030 0.0165 0.0135)
+(0.0000 0.0165 0.0135)
+(0.0030 0.0165 0.0135)
+(0.0060 0.0165 0.0135)
+(-0.0060 0.0195 0.0135)
+(-0.0030 0.0195 0.0135)
+(0.0000 0.0195 0.0135)
+(0.0030 0.0195 0.0135)
+(0.0060 0.0195 0.0135)
+(-0.0060 0.0225 0.0135)
+(-0.0030 0.0225 0.0135)
+(0.0000 0.0225 0.0135)
+(0.0030 0.0225 0.0135)
+(0.0060 0.0225 0.0135)
+(-0.0060 0.0255 0.0135)
+(-0.0030 0.0255 0.0135)
+(0.0000 0.0255 0.0135)
+(0.0030 0.0255 0.0135)
+(0.0060 0.0255 0.0135)
+(-0.0060 0.0285 0.0135)
+(-0.0030 0.0285 0.0135)
+(0.0000 0.0285 0.0135)
+(0.0030 0.0285 0.0135)
+(0.0060 0.0285 0.0135)
+(-0.0060 0.0315 0.0135)
+(-0.0030 0.0315 0.0135)
+(0.0000 0.0315 0.0135)
+(0.0030 0.0315 0.0135)
+(0.0060 0.0315 0.0135)
+(-0.0060 0.0345 0.0135)
+(-0.0030 0.0345 0.0135)
+(0.0000 0.0345 0.0135)
+(0.0030 0.0345 0.0135)
+(0.0060 0.0345 0.0135)
+(-0.0060 0.0375 0.0135)
+(-0.0030 0.0375 0.0135)
+(0.0000 0.0375 0.0135)
+(0.0030 0.0375 0.0135)
+(0.0060 0.0375 0.0135)
+(-0.0060 0.0405 0.0135)
+(-0.0030 0.0405 0.0135)
+(0.0000 0.0405 0.0135)
+(0.0030 0.0405 0.0135)
+(0.0060 0.0405 0.0135)
+(-0.0060 0.0435 0.0135)
+(-0.0030 0.0435 0.0135)
+(0.0000 0.0435 0.0135)
+(0.0030 0.0435 0.0135)
+(0.0060 0.0435 0.0135)
+(-0.0060 0.0465 0.0135)
+(-0.0030 0.0465 0.0135)
+(0.0000 0.0465 0.0135)
+(0.0030 0.0465 0.0135)
+(0.0060 0.0465 0.0135)
+(-0.0060 0.0495 0.0135)
+(-0.0030 0.0495 0.0135)
+(0.0000 0.0495 0.0135)
+(0.0030 0.0495 0.0135)
+(0.0060 0.0495 0.0135)
+(-0.0060 0.0525 0.0135)
+(-0.0030 0.0525 0.0135)
+(0.0000 0.0525 0.0135)
+(0.0030 0.0525 0.0135)
+(0.0060 0.0525 0.0135)
+(-0.0060 0.0555 0.0135)
+(-0.0030 0.0555 0.0135)
+(0.0000 0.0555 0.0135)
+(0.0030 0.0555 0.0135)
+(0.0060 0.0555 0.0135)
+(-0.0060 0.0585 0.0135)
+(-0.0030 0.0585 0.0135)
+(0.0000 0.0585 0.0135)
+(0.0030 0.0585 0.0135)
+(0.0060 0.0585 0.0135)
+(-0.0060 0.0615 0.0135)
+(-0.0030 0.0615 0.0135)
+(0.0000 0.0615 0.0135)
+(0.0030 0.0615 0.0135)
+(0.0060 0.0615 0.0135)
+(-0.0060 0.0645 0.0135)
+(-0.0030 0.0645 0.0135)
+(0.0000 0.0645 0.0135)
+(0.0030 0.0645 0.0135)
+(0.0060 0.0645 0.0135)
+(-0.0060 0.0675 0.0135)
+(-0.0030 0.0675 0.0135)
+(0.0000 0.0675 0.0135)
+(0.0030 0.0675 0.0135)
+(0.0060 0.0675 0.0135)
+(-0.0060 0.0705 0.0135)
+(-0.0030 0.0705 0.0135)
+(0.0000 0.0705 0.0135)
+(0.0030 0.0705 0.0135)
+(0.0060 0.0705 0.0135)
+(-0.0060 0.0735 0.0135)
+(-0.0030 0.0735 0.0135)
+(0.0000 0.0735 0.0135)
+(0.0030 0.0735 0.0135)
+(0.0060 0.0735 0.0135)
+(-0.0060 -0.0735 0.0165)
+(-0.0030 -0.0735 0.0165)
+(0.0000 -0.0735 0.0165)
+(0.0030 -0.0735 0.0165)
+(0.0060 -0.0735 0.0165)
+(-0.0060 -0.0705 0.0165)
+(-0.0030 -0.0705 0.0165)
+(0.0000 -0.0705 0.0165)
+(0.0030 -0.0705 0.0165)
+(0.0060 -0.0705 0.0165)
+(-0.0060 -0.0675 0.0165)
+(-0.0030 -0.0675 0.0165)
+(0.0000 -0.0675 0.0165)
+(0.0030 -0.0675 0.0165)
+(0.0060 -0.0675 0.0165)
+(-0.0060 -0.0645 0.0165)
+(-0.0030 -0.0645 0.0165)
+(0.0000 -0.0645 0.0165)
+(0.0030 -0.0645 0.0165)
+(0.0060 -0.0645 0.0165)
+(-0.0060 -0.0615 0.0165)
+(-0.0030 -0.0615 0.0165)
+(0.0000 -0.0615 0.0165)
+(0.0030 -0.0615 0.0165)
+(0.0060 -0.0615 0.0165)
+(-0.0060 -0.0585 0.0165)
+(-0.0030 -0.0585 0.0165)
+(0.0000 -0.0585 0.0165)
+(0.0030 -0.0585 0.0165)
+(0.0060 -0.0585 0.0165)
+(-0.0060 -0.0555 0.0165)
+(-0.0030 -0.0555 0.0165)
+(0.0000 -0.0555 0.0165)
+(0.0030 -0.0555 0.0165)
+(0.0060 -0.0555 0.0165)
+(-0.0060 -0.0525 0.0165)
+(-0.0030 -0.0525 0.0165)
+(0.0000 -0.0525 0.0165)
+(0.0030 -0.0525 0.0165)
+(0.0060 -0.0525 0.0165)
+(-0.0060 -0.0495 0.0165)
+(-0.0030 -0.0495 0.0165)
+(0.0000 -0.0495 0.0165)
+(0.0030 -0.0495 0.0165)
+(0.0060 -0.0495 0.0165)
+(-0.0060 -0.0465 0.0165)
+(-0.0030 -0.0465 0.0165)
+(0.0000 -0.0465 0.0165)
+(0.0030 -0.0465 0.0165)
+(0.0060 -0.0465 0.0165)
+(-0.0060 -0.0435 0.0165)
+(-0.0030 -0.0435 0.0165)
+(0.0000 -0.0435 0.0165)
+(0.0030 -0.0435 0.0165)
+(0.0060 -0.0435 0.0165)
+(-0.0060 -0.0405 0.0165)
+(-0.0030 -0.0405 0.0165)
+(0.0000 -0.0405 0.0165)
+(0.0030 -0.0405 0.0165)
+(0.0060 -0.0405 0.0165)
+(-0.0060 -0.0375 0.0165)
+(-0.0030 -0.0375 0.0165)
+(0.0000 -0.0375 0.0165)
+(0.0030 -0.0375 0.0165)
+(0.0060 -0.0375 0.0165)
+(-0.0060 -0.0345 0.0165)
+(-0.0030 -0.0345 0.0165)
+(0.0000 -0.0345 0.0165)
+(0.0030 -0.0345 0.0165)
+(0.0060 -0.0345 0.0165)
+(-0.0060 -0.0315 0.0165)
+(-0.0030 -0.0315 0.0165)
+(0.0000 -0.0315 0.0165)
+(0.0030 -0.0315 0.0165)
+(0.0060 -0.0315 0.0165)
+(-0.0060 -0.0285 0.0165)
+(-0.0030 -0.0285 0.0165)
+(0.0000 -0.0285 0.0165)
+(0.0030 -0.0285 0.0165)
+(0.0060 -0.0285 0.0165)
+(-0.0060 -0.0255 0.0165)
+(-0.0030 -0.0255 0.0165)
+(0.0000 -0.0255 0.0165)
+(0.0030 -0.0255 0.0165)
+(0.0060 -0.0255 0.0165)
+(-0.0060 -0.0225 0.0165)
+(-0.0030 -0.0225 0.0165)
+(0.0000 -0.0225 0.0165)
+(0.0030 -0.0225 0.0165)
+(0.0060 -0.0225 0.0165)
+(-0.0060 -0.0195 0.0165)
+(-0.0030 -0.0195 0.0165)
+(0.0000 -0.0195 0.0165)
+(0.0030 -0.0195 0.0165)
+(0.0060 -0.0195 0.0165)
+(-0.0060 -0.0165 0.0165)
+(-0.0030 -0.0165 0.0165)
+(0.0000 -0.0165 0.0165)
+(0.0030 -0.0165 0.0165)
+(0.0060 -0.0165 0.0165)
+(-0.0060 -0.0135 0.0165)
+(-0.0030 -0.0135 0.0165)
+(0.0000 -0.0135 0.0165)
+(0.0030 -0.0135 0.0165)
+(0.0060 -0.0135 0.0165)
+(-0.0060 -0.0105 0.0165)
+(-0.0030 -0.0105 0.0165)
+(0.0000 -0.0105 0.0165)
+(0.0030 -0.0105 0.0165)
+(0.0060 -0.0105 0.0165)
+(-0.0060 -0.0075 0.0165)
+(-0.0030 -0.0075 0.0165)
+(0.0000 -0.0075 0.0165)
+(0.0030 -0.0075 0.0165)
+(0.0060 -0.0075 0.0165)
+(-0.0060 -0.0045 0.0165)
+(-0.0030 -0.0045 0.0165)
+(0.0000 -0.0045 0.0165)
+(0.0030 -0.0045 0.0165)
+(0.0060 -0.0045 0.0165)
+(-0.0060 -0.0015 0.0165)
+(-0.0030 -0.0015 0.0165)
+(0.0000 -0.0015 0.0165)
+(0.0030 -0.0015 0.0165)
+(0.0060 -0.0015 0.0165)
+(-0.0060 0.0015 0.0165)
+(-0.0030 0.0015 0.0165)
+(0.0000 0.0015 0.0165)
+(0.0030 0.0015 0.0165)
+(0.0060 0.0015 0.0165)
+(-0.0060 0.0045 0.0165)
+(-0.0030 0.0045 0.0165)
+(0.0000 0.0045 0.0165)
+(0.0030 0.0045 0.0165)
+(0.0060 0.0045 0.0165)
+(-0.0060 0.0075 0.0165)
+(-0.0030 0.0075 0.0165)
+(0.0000 0.0075 0.0165)
+(0.0030 0.0075 0.0165)
+(0.0060 0.0075 0.0165)
+(-0.0060 0.0105 0.0165)
+(-0.0030 0.0105 0.0165)
+(0.0000 0.0105 0.0165)
+(0.0030 0.0105 0.0165)
+(0.0060 0.0105 0.0165)
+(-0.0060 0.0135 0.0165)
+(-0.0030 0.0135 0.0165)
+(0.0000 0.0135 0.0165)
+(0.0030 0.0135 0.0165)
+(0.0060 0.0135 0.0165)
+(-0.0060 0.0165 0.0165)
+(-0.0030 0.0165 0.0165)
+(0.0000 0.0165 0.0165)
+(0.0030 0.0165 0.0165)
+(0.0060 0.0165 0.0165)
+(-0.0060 0.0195 0.0165)
+(-0.0030 0.0195 0.0165)
+(0.0000 0.0195 0.0165)
+(0.0030 0.0195 0.0165)
+(0.0060 0.0195 0.0165)
+(-0.0060 0.0225 0.0165)
+(-0.0030 0.0225 0.0165)
+(0.0000 0.0225 0.0165)
+(0.0030 0.0225 0.0165)
+(0.0060 0.0225 0.0165)
+(-0.0060 0.0255 0.0165)
+(-0.0030 0.0255 0.0165)
+(0.0000 0.0255 0.0165)
+(0.0030 0.0255 0.0165)
+(0.0060 0.0255 0.0165)
+(-0.0060 0.0285 0.0165)
+(-0.0030 0.0285 0.0165)
+(0.0000 0.0285 0.0165)
+(0.0030 0.0285 0.0165)
+(0.0060 0.0285 0.0165)
+(-0.0060 0.0315 0.0165)
+(-0.0030 0.0315 0.0165)
+(0.0000 0.0315 0.0165)
+(0.0030 0.0315 0.0165)
+(0.0060 0.0315 0.0165)
+(-0.0060 0.0345 0.0165)
+(-0.0030 0.0345 0.0165)
+(0.0000 0.0345 0.0165)
+(0.0030 0.0345 0.0165)
+(0.0060 0.0345 0.0165)
+(-0.0060 0.0375 0.0165)
+(-0.0030 0.0375 0.0165)
+(0.0000 0.0375 0.0165)
+(0.0030 0.0375 0.0165)
+(0.0060 0.0375 0.0165)
+(-0.0060 0.0405 0.0165)
+(-0.0030 0.0405 0.0165)
+(0.0000 0.0405 0.0165)
+(0.0030 0.0405 0.0165)
+(0.0060 0.0405 0.0165)
+(-0.0060 0.0435 0.0165)
+(-0.0030 0.0435 0.0165)
+(0.0000 0.0435 0.0165)
+(0.0030 0.0435 0.0165)
+(0.0060 0.0435 0.0165)
+(-0.0060 0.0465 0.0165)
+(-0.0030 0.0465 0.0165)
+(0.0000 0.0465 0.0165)
+(0.0030 0.0465 0.0165)
+(0.0060 0.0465 0.0165)
+(-0.0060 0.0495 0.0165)
+(-0.0030 0.0495 0.0165)
+(0.0000 0.0495 0.0165)
+(0.0030 0.0495 0.0165)
+(0.0060 0.0495 0.0165)
+(-0.0060 0.0525 0.0165)
+(-0.0030 0.0525 0.0165)
+(0.0000 0.0525 0.0165)
+(0.0030 0.0525 0.0165)
+(0.0060 0.0525 0.0165)
+(-0.0060 0.0555 0.0165)
+(-0.0030 0.0555 0.0165)
+(0.0000 0.0555 0.0165)
+(0.0030 0.0555 0.0165)
+(0.0060 0.0555 0.0165)
+(-0.0060 0.0585 0.0165)
+(-0.0030 0.0585 0.0165)
+(0.0000 0.0585 0.0165)
+(0.0030 0.0585 0.0165)
+(0.0060 0.0585 0.0165)
+(-0.0060 0.0615 0.0165)
+(-0.0030 0.0615 0.0165)
+(0.0000 0.0615 0.0165)
+(0.0030 0.0615 0.0165)
+(0.0060 0.0615 0.0165)
+(-0.0060 0.0645 0.0165)
+(-0.0030 0.0645 0.0165)
+(0.0000 0.0645 0.0165)
+(0.0030 0.0645 0.0165)
+(0.0060 0.0645 0.0165)
+(-0.0060 0.0675 0.0165)
+(-0.0030 0.0675 0.0165)
+(0.0000 0.0675 0.0165)
+(0.0030 0.0675 0.0165)
+(0.0060 0.0675 0.0165)
+(-0.0060 0.0705 0.0165)
+(-0.0030 0.0705 0.0165)
+(0.0000 0.0705 0.0165)
+(0.0030 0.0705 0.0165)
+(0.0060 0.0705 0.0165)
+(-0.0060 0.0735 0.0165)
+(-0.0030 0.0735 0.0165)
+(0.0000 0.0735 0.0165)
+(0.0030 0.0735 0.0165)
+(0.0060 0.0735 0.0165)
+(-0.0060 -0.0735 0.0195)
+(-0.0030 -0.0735 0.0195)
+(0.0000 -0.0735 0.0195)
+(0.0030 -0.0735 0.0195)
+(0.0060 -0.0735 0.0195)
+(-0.0060 -0.0705 0.0195)
+(-0.0030 -0.0705 0.0195)
+(0.0000 -0.0705 0.0195)
+(0.0030 -0.0705 0.0195)
+(0.0060 -0.0705 0.0195)
+(-0.0060 -0.0675 0.0195)
+(-0.0030 -0.0675 0.0195)
+(0.0000 -0.0675 0.0195)
+(0.0030 -0.0675 0.0195)
+(0.0060 -0.0675 0.0195)
+(-0.0060 -0.0645 0.0195)
+(-0.0030 -0.0645 0.0195)
+(0.0000 -0.0645 0.0195)
+(0.0030 -0.0645 0.0195)
+(0.0060 -0.0645 0.0195)
+(-0.0060 -0.0615 0.0195)
+(-0.0030 -0.0615 0.0195)
+(0.0000 -0.0615 0.0195)
+(0.0030 -0.0615 0.0195)
+(0.0060 -0.0615 0.0195)
+(-0.0060 -0.0585 0.0195)
+(-0.0030 -0.0585 0.0195)
+(0.0000 -0.0585 0.0195)
+(0.0030 -0.0585 0.0195)
+(0.0060 -0.0585 0.0195)
+(-0.0060 -0.0555 0.0195)
+(-0.0030 -0.0555 0.0195)
+(0.0000 -0.0555 0.0195)
+(0.0030 -0.0555 0.0195)
+(0.0060 -0.0555 0.0195)
+(-0.0060 -0.0525 0.0195)
+(-0.0030 -0.0525 0.0195)
+(0.0000 -0.0525 0.0195)
+(0.0030 -0.0525 0.0195)
+(0.0060 -0.0525 0.0195)
+(-0.0060 -0.0495 0.0195)
+(-0.0030 -0.0495 0.0195)
+(0.0000 -0.0495 0.0195)
+(0.0030 -0.0495 0.0195)
+(0.0060 -0.0495 0.0195)
+(-0.0060 -0.0465 0.0195)
+(-0.0030 -0.0465 0.0195)
+(0.0000 -0.0465 0.0195)
+(0.0030 -0.0465 0.0195)
+(0.0060 -0.0465 0.0195)
+(-0.0060 -0.0435 0.0195)
+(-0.0030 -0.0435 0.0195)
+(0.0000 -0.0435 0.0195)
+(0.0030 -0.0435 0.0195)
+(0.0060 -0.0435 0.0195)
+(-0.0060 -0.0405 0.0195)
+(-0.0030 -0.0405 0.0195)
+(0.0000 -0.0405 0.0195)
+(0.0030 -0.0405 0.0195)
+(0.0060 -0.0405 0.0195)
+(-0.0060 -0.0375 0.0195)
+(-0.0030 -0.0375 0.0195)
+(0.0000 -0.0375 0.0195)
+(0.0030 -0.0375 0.0195)
+(0.0060 -0.0375 0.0195)
+(-0.0060 -0.0345 0.0195)
+(-0.0030 -0.0345 0.0195)
+(0.0000 -0.0345 0.0195)
+(0.0030 -0.0345 0.0195)
+(0.0060 -0.0345 0.0195)
+(-0.0060 -0.0315 0.0195)
+(-0.0030 -0.0315 0.0195)
+(0.0000 -0.0315 0.0195)
+(0.0030 -0.0315 0.0195)
+(0.0060 -0.0315 0.0195)
+(-0.0060 -0.0285 0.0195)
+(-0.0030 -0.0285 0.0195)
+(0.0000 -0.0285 0.0195)
+(0.0030 -0.0285 0.0195)
+(0.0060 -0.0285 0.0195)
+(-0.0060 -0.0255 0.0195)
+(-0.0030 -0.0255 0.0195)
+(0.0000 -0.0255 0.0195)
+(0.0030 -0.0255 0.0195)
+(0.0060 -0.0255 0.0195)
+(-0.0060 -0.0225 0.0195)
+(-0.0030 -0.0225 0.0195)
+(0.0000 -0.0225 0.0195)
+(0.0030 -0.0225 0.0195)
+(0.0060 -0.0225 0.0195)
+(-0.0060 -0.0195 0.0195)
+(-0.0030 -0.0195 0.0195)
+(0.0000 -0.0195 0.0195)
+(0.0030 -0.0195 0.0195)
+(0.0060 -0.0195 0.0195)
+(-0.0060 -0.0165 0.0195)
+(-0.0030 -0.0165 0.0195)
+(0.0000 -0.0165 0.0195)
+(0.0030 -0.0165 0.0195)
+(0.0060 -0.0165 0.0195)
+(-0.0060 -0.0135 0.0195)
+(-0.0030 -0.0135 0.0195)
+(0.0000 -0.0135 0.0195)
+(0.0030 -0.0135 0.0195)
+(0.0060 -0.0135 0.0195)
+(-0.0060 -0.0105 0.0195)
+(-0.0030 -0.0105 0.0195)
+(0.0000 -0.0105 0.0195)
+(0.0030 -0.0105 0.0195)
+(0.0060 -0.0105 0.0195)
+(-0.0060 -0.0075 0.0195)
+(-0.0030 -0.0075 0.0195)
+(0.0000 -0.0075 0.0195)
+(0.0030 -0.0075 0.0195)
+(0.0060 -0.0075 0.0195)
+(-0.0060 -0.0045 0.0195)
+(-0.0030 -0.0045 0.0195)
+(0.0000 -0.0045 0.0195)
+(0.0030 -0.0045 0.0195)
+(0.0060 -0.0045 0.0195)
+(-0.0060 -0.0015 0.0195)
+(-0.0030 -0.0015 0.0195)
+(0.0000 -0.0015 0.0195)
+(0.0030 -0.0015 0.0195)
+(0.0060 -0.0015 0.0195)
+(-0.0060 0.0015 0.0195)
+(-0.0030 0.0015 0.0195)
+(0.0000 0.0015 0.0195)
+(0.0030 0.0015 0.0195)
+(0.0060 0.0015 0.0195)
+(-0.0060 0.0045 0.0195)
+(-0.0030 0.0045 0.0195)
+(0.0000 0.0045 0.0195)
+(0.0030 0.0045 0.0195)
+(0.0060 0.0045 0.0195)
+(-0.0060 0.0075 0.0195)
+(-0.0030 0.0075 0.0195)
+(0.0000 0.0075 0.0195)
+(0.0030 0.0075 0.0195)
+(0.0060 0.0075 0.0195)
+(-0.0060 0.0105 0.0195)
+(-0.0030 0.0105 0.0195)
+(0.0000 0.0105 0.0195)
+(0.0030 0.0105 0.0195)
+(0.0060 0.0105 0.0195)
+(-0.0060 0.0135 0.0195)
+(-0.0030 0.0135 0.0195)
+(0.0000 0.0135 0.0195)
+(0.0030 0.0135 0.0195)
+(0.0060 0.0135 0.0195)
+(-0.0060 0.0165 0.0195)
+(-0.0030 0.0165 0.0195)
+(0.0000 0.0165 0.0195)
+(0.0030 0.0165 0.0195)
+(0.0060 0.0165 0.0195)
+(-0.0060 0.0195 0.0195)
+(-0.0030 0.0195 0.0195)
+(0.0000 0.0195 0.0195)
+(0.0030 0.0195 0.0195)
+(0.0060 0.0195 0.0195)
+(-0.0060 0.0225 0.0195)
+(-0.0030 0.0225 0.0195)
+(0.0000 0.0225 0.0195)
+(0.0030 0.0225 0.0195)
+(0.0060 0.0225 0.0195)
+(-0.0060 0.0255 0.0195)
+(-0.0030 0.0255 0.0195)
+(0.0000 0.0255 0.0195)
+(0.0030 0.0255 0.0195)
+(0.0060 0.0255 0.0195)
+(-0.0060 0.0285 0.0195)
+(-0.0030 0.0285 0.0195)
+(0.0000 0.0285 0.0195)
+(0.0030 0.0285 0.0195)
+(0.0060 0.0285 0.0195)
+(-0.0060 0.0315 0.0195)
+(-0.0030 0.0315 0.0195)
+(0.0000 0.0315 0.0195)
+(0.0030 0.0315 0.0195)
+(0.0060 0.0315 0.0195)
+(-0.0060 0.0345 0.0195)
+(-0.0030 0.0345 0.0195)
+(0.0000 0.0345 0.0195)
+(0.0030 0.0345 0.0195)
+(0.0060 0.0345 0.0195)
+(-0.0060 0.0375 0.0195)
+(-0.0030 0.0375 0.0195)
+(0.0000 0.0375 0.0195)
+(0.0030 0.0375 0.0195)
+(0.0060 0.0375 0.0195)
+(-0.0060 0.0405 0.0195)
+(-0.0030 0.0405 0.0195)
+(0.0000 0.0405 0.0195)
+(0.0030 0.0405 0.0195)
+(0.0060 0.0405 0.0195)
+(-0.0060 0.0435 0.0195)
+(-0.0030 0.0435 0.0195)
+(0.0000 0.0435 0.0195)
+(0.0030 0.0435 0.0195)
+(0.0060 0.0435 0.0195)
+(-0.0060 0.0465 0.0195)
+(-0.0030 0.0465 0.0195)
+(0.0000 0.0465 0.0195)
+(0.0030 0.0465 0.0195)
+(0.0060 0.0465 0.0195)
+(-0.0060 0.0495 0.0195)
+(-0.0030 0.0495 0.0195)
+(0.0000 0.0495 0.0195)
+(0.0030 0.0495 0.0195)
+(0.0060 0.0495 0.0195)
+(-0.0060 0.0525 0.0195)
+(-0.0030 0.0525 0.0195)
+(0.0000 0.0525 0.0195)
+(0.0030 0.0525 0.0195)
+(0.0060 0.0525 0.0195)
+(-0.0060 0.0555 0.0195)
+(-0.0030 0.0555 0.0195)
+(0.0000 0.0555 0.0195)
+(0.0030 0.0555 0.0195)
+(0.0060 0.0555 0.0195)
+(-0.0060 0.0585 0.0195)
+(-0.0030 0.0585 0.0195)
+(0.0000 0.0585 0.0195)
+(0.0030 0.0585 0.0195)
+(0.0060 0.0585 0.0195)
+(-0.0060 0.0615 0.0195)
+(-0.0030 0.0615 0.0195)
+(0.0000 0.0615 0.0195)
+(0.0030 0.0615 0.0195)
+(0.0060 0.0615 0.0195)
+(-0.0060 0.0645 0.0195)
+(-0.0030 0.0645 0.0195)
+(0.0000 0.0645 0.0195)
+(0.0030 0.0645 0.0195)
+(0.0060 0.0645 0.0195)
+(-0.0060 0.0675 0.0195)
+(-0.0030 0.0675 0.0195)
+(0.0000 0.0675 0.0195)
+(0.0030 0.0675 0.0195)
+(0.0060 0.0675 0.0195)
+(-0.0060 0.0705 0.0195)
+(-0.0030 0.0705 0.0195)
+(0.0000 0.0705 0.0195)
+(0.0030 0.0705 0.0195)
+(0.0060 0.0705 0.0195)
+(-0.0060 0.0735 0.0195)
+(-0.0030 0.0735 0.0195)
+(0.0000 0.0735 0.0195)
+(0.0030 0.0735 0.0195)
+(0.0060 0.0735 0.0195)
+(-0.0060 -0.0735 0.0225)
+(-0.0030 -0.0735 0.0225)
+(0.0000 -0.0735 0.0225)
+(0.0030 -0.0735 0.0225)
+(0.0060 -0.0735 0.0225)
+(-0.0060 -0.0705 0.0225)
+(-0.0030 -0.0705 0.0225)
+(0.0000 -0.0705 0.0225)
+(0.0030 -0.0705 0.0225)
+(0.0060 -0.0705 0.0225)
+(-0.0060 -0.0675 0.0225)
+(-0.0030 -0.0675 0.0225)
+(0.0000 -0.0675 0.0225)
+(0.0030 -0.0675 0.0225)
+(0.0060 -0.0675 0.0225)
+(-0.0060 -0.0645 0.0225)
+(-0.0030 -0.0645 0.0225)
+(0.0000 -0.0645 0.0225)
+(0.0030 -0.0645 0.0225)
+(0.0060 -0.0645 0.0225)
+(-0.0060 -0.0615 0.0225)
+(-0.0030 -0.0615 0.0225)
+(0.0000 -0.0615 0.0225)
+(0.0030 -0.0615 0.0225)
+(0.0060 -0.0615 0.0225)
+(-0.0060 -0.0585 0.0225)
+(-0.0030 -0.0585 0.0225)
+(0.0000 -0.0585 0.0225)
+(0.0030 -0.0585 0.0225)
+(0.0060 -0.0585 0.0225)
+(-0.0060 -0.0555 0.0225)
+(-0.0030 -0.0555 0.0225)
+(0.0000 -0.0555 0.0225)
+(0.0030 -0.0555 0.0225)
+(0.0060 -0.0555 0.0225)
+(-0.0060 -0.0525 0.0225)
+(-0.0030 -0.0525 0.0225)
+(0.0000 -0.0525 0.0225)
+(0.0030 -0.0525 0.0225)
+(0.0060 -0.0525 0.0225)
+(-0.0060 -0.0495 0.0225)
+(-0.0030 -0.0495 0.0225)
+(0.0000 -0.0495 0.0225)
+(0.0030 -0.0495 0.0225)
+(0.0060 -0.0495 0.0225)
+(-0.0060 -0.0465 0.0225)
+(-0.0030 -0.0465 0.0225)
+(0.0000 -0.0465 0.0225)
+(0.0030 -0.0465 0.0225)
+(0.0060 -0.0465 0.0225)
+(-0.0060 -0.0435 0.0225)
+(-0.0030 -0.0435 0.0225)
+(0.0000 -0.0435 0.0225)
+(0.0030 -0.0435 0.0225)
+(0.0060 -0.0435 0.0225)
+(-0.0060 -0.0405 0.0225)
+(-0.0030 -0.0405 0.0225)
+(0.0000 -0.0405 0.0225)
+(0.0030 -0.0405 0.0225)
+(0.0060 -0.0405 0.0225)
+(-0.0060 -0.0375 0.0225)
+(-0.0030 -0.0375 0.0225)
+(0.0000 -0.0375 0.0225)
+(0.0030 -0.0375 0.0225)
+(0.0060 -0.0375 0.0225)
+(-0.0060 -0.0345 0.0225)
+(-0.0030 -0.0345 0.0225)
+(0.0000 -0.0345 0.0225)
+(0.0030 -0.0345 0.0225)
+(0.0060 -0.0345 0.0225)
+(-0.0060 -0.0315 0.0225)
+(-0.0030 -0.0315 0.0225)
+(0.0000 -0.0315 0.0225)
+(0.0030 -0.0315 0.0225)
+(0.0060 -0.0315 0.0225)
+(-0.0060 -0.0285 0.0225)
+(-0.0030 -0.0285 0.0225)
+(0.0000 -0.0285 0.0225)
+(0.0030 -0.0285 0.0225)
+(0.0060 -0.0285 0.0225)
+(-0.0060 -0.0255 0.0225)
+(-0.0030 -0.0255 0.0225)
+(0.0000 -0.0255 0.0225)
+(0.0030 -0.0255 0.0225)
+(0.0060 -0.0255 0.0225)
+(-0.0060 -0.0225 0.0225)
+(-0.0030 -0.0225 0.0225)
+(0.0000 -0.0225 0.0225)
+(0.0030 -0.0225 0.0225)
+(0.0060 -0.0225 0.0225)
+(-0.0060 -0.0195 0.0225)
+(-0.0030 -0.0195 0.0225)
+(0.0000 -0.0195 0.0225)
+(0.0030 -0.0195 0.0225)
+(0.0060 -0.0195 0.0225)
+(-0.0060 -0.0165 0.0225)
+(-0.0030 -0.0165 0.0225)
+(0.0000 -0.0165 0.0225)
+(0.0030 -0.0165 0.0225)
+(0.0060 -0.0165 0.0225)
+(-0.0060 -0.0135 0.0225)
+(-0.0030 -0.0135 0.0225)
+(0.0000 -0.0135 0.0225)
+(0.0030 -0.0135 0.0225)
+(0.0060 -0.0135 0.0225)
+(-0.0060 -0.0105 0.0225)
+(-0.0030 -0.0105 0.0225)
+(0.0000 -0.0105 0.0225)
+(0.0030 -0.0105 0.0225)
+(0.0060 -0.0105 0.0225)
+(-0.0060 -0.0075 0.0225)
+(-0.0030 -0.0075 0.0225)
+(0.0000 -0.0075 0.0225)
+(0.0030 -0.0075 0.0225)
+(0.0060 -0.0075 0.0225)
+(-0.0060 -0.0045 0.0225)
+(-0.0030 -0.0045 0.0225)
+(0.0000 -0.0045 0.0225)
+(0.0030 -0.0045 0.0225)
+(0.0060 -0.0045 0.0225)
+(-0.0060 -0.0015 0.0225)
+(-0.0030 -0.0015 0.0225)
+(0.0000 -0.0015 0.0225)
+(0.0030 -0.0015 0.0225)
+(0.0060 -0.0015 0.0225)
+(-0.0060 0.0015 0.0225)
+(-0.0030 0.0015 0.0225)
+(0.0000 0.0015 0.0225)
+(0.0030 0.0015 0.0225)
+(0.0060 0.0015 0.0225)
+(-0.0060 0.0045 0.0225)
+(-0.0030 0.0045 0.0225)
+(0.0000 0.0045 0.0225)
+(0.0030 0.0045 0.0225)
+(0.0060 0.0045 0.0225)
+(-0.0060 0.0075 0.0225)
+(-0.0030 0.0075 0.0225)
+(0.0000 0.0075 0.0225)
+(0.0030 0.0075 0.0225)
+(0.0060 0.0075 0.0225)
+(-0.0060 0.0105 0.0225)
+(-0.0030 0.0105 0.0225)
+(0.0000 0.0105 0.0225)
+(0.0030 0.0105 0.0225)
+(0.0060 0.0105 0.0225)
+(-0.0060 0.0135 0.0225)
+(-0.0030 0.0135 0.0225)
+(0.0000 0.0135 0.0225)
+(0.0030 0.0135 0.0225)
+(0.0060 0.0135 0.0225)
+(-0.0060 0.0165 0.0225)
+(-0.0030 0.0165 0.0225)
+(0.0000 0.0165 0.0225)
+(0.0030 0.0165 0.0225)
+(0.0060 0.0165 0.0225)
+(-0.0060 0.0195 0.0225)
+(-0.0030 0.0195 0.0225)
+(0.0000 0.0195 0.0225)
+(0.0030 0.0195 0.0225)
+(0.0060 0.0195 0.0225)
+(-0.0060 0.0225 0.0225)
+(-0.0030 0.0225 0.0225)
+(0.0000 0.0225 0.0225)
+(0.0030 0.0225 0.0225)
+(0.0060 0.0225 0.0225)
+(-0.0060 0.0255 0.0225)
+(-0.0030 0.0255 0.0225)
+(0.0000 0.0255 0.0225)
+(0.0030 0.0255 0.0225)
+(0.0060 0.0255 0.0225)
+(-0.0060 0.0285 0.0225)
+(-0.0030 0.0285 0.0225)
+(0.0000 0.0285 0.0225)
+(0.0030 0.0285 0.0225)
+(0.0060 0.0285 0.0225)
+(-0.0060 0.0315 0.0225)
+(-0.0030 0.0315 0.0225)
+(0.0000 0.0315 0.0225)
+(0.0030 0.0315 0.0225)
+(0.0060 0.0315 0.0225)
+(-0.0060 0.0345 0.0225)
+(-0.0030 0.0345 0.0225)
+(0.0000 0.0345 0.0225)
+(0.0030 0.0345 0.0225)
+(0.0060 0.0345 0.0225)
+(-0.0060 0.0375 0.0225)
+(-0.0030 0.0375 0.0225)
+(0.0000 0.0375 0.0225)
+(0.0030 0.0375 0.0225)
+(0.0060 0.0375 0.0225)
+(-0.0060 0.0405 0.0225)
+(-0.0030 0.0405 0.0225)
+(0.0000 0.0405 0.0225)
+(0.0030 0.0405 0.0225)
+(0.0060 0.0405 0.0225)
+(-0.0060 0.0435 0.0225)
+(-0.0030 0.0435 0.0225)
+(0.0000 0.0435 0.0225)
+(0.0030 0.0435 0.0225)
+(0.0060 0.0435 0.0225)
+(-0.0060 0.0465 0.0225)
+(-0.0030 0.0465 0.0225)
+(0.0000 0.0465 0.0225)
+(0.0030 0.0465 0.0225)
+(0.0060 0.0465 0.0225)
+(-0.0060 0.0495 0.0225)
+(-0.0030 0.0495 0.0225)
+(0.0000 0.0495 0.0225)
+(0.0030 0.0495 0.0225)
+(0.0060 0.0495 0.0225)
+(-0.0060 0.0525 0.0225)
+(-0.0030 0.0525 0.0225)
+(0.0000 0.0525 0.0225)
+(0.0030 0.0525 0.0225)
+(0.0060 0.0525 0.0225)
+(-0.0060 0.0555 0.0225)
+(-0.0030 0.0555 0.0225)
+(0.0000 0.0555 0.0225)
+(0.0030 0.0555 0.0225)
+(0.0060 0.0555 0.0225)
+(-0.0060 0.0585 0.0225)
+(-0.0030 0.0585 0.0225)
+(0.0000 0.0585 0.0225)
+(0.0030 0.0585 0.0225)
+(0.0060 0.0585 0.0225)
+(-0.0060 0.0615 0.0225)
+(-0.0030 0.0615 0.0225)
+(0.0000 0.0615 0.0225)
+(0.0030 0.0615 0.0225)
+(0.0060 0.0615 0.0225)
+(-0.0060 0.0645 0.0225)
+(-0.0030 0.0645 0.0225)
+(0.0000 0.0645 0.0225)
+(0.0030 0.0645 0.0225)
+(0.0060 0.0645 0.0225)
+(-0.0060 0.0675 0.0225)
+(-0.0030 0.0675 0.0225)
+(0.0000 0.0675 0.0225)
+(0.0030 0.0675 0.0225)
+(0.0060 0.0675 0.0225)
+(-0.0060 0.0705 0.0225)
+(-0.0030 0.0705 0.0225)
+(0.0000 0.0705 0.0225)
+(0.0030 0.0705 0.0225)
+(0.0060 0.0705 0.0225)
+(-0.0060 0.0735 0.0225)
+(-0.0030 0.0735 0.0225)
+(0.0000 0.0735 0.0225)
+(0.0030 0.0735 0.0225)
+(0.0060 0.0735 0.0225)
+(-0.0060 -0.0735 0.0255)
+(-0.0030 -0.0735 0.0255)
+(0.0000 -0.0735 0.0255)
+(0.0030 -0.0735 0.0255)
+(0.0060 -0.0735 0.0255)
+(-0.0060 -0.0705 0.0255)
+(-0.0030 -0.0705 0.0255)
+(0.0000 -0.0705 0.0255)
+(0.0030 -0.0705 0.0255)
+(0.0060 -0.0705 0.0255)
+(-0.0060 -0.0675 0.0255)
+(-0.0030 -0.0675 0.0255)
+(0.0000 -0.0675 0.0255)
+(0.0030 -0.0675 0.0255)
+(0.0060 -0.0675 0.0255)
+(-0.0060 -0.0645 0.0255)
+(-0.0030 -0.0645 0.0255)
+(0.0000 -0.0645 0.0255)
+(0.0030 -0.0645 0.0255)
+(0.0060 -0.0645 0.0255)
+(-0.0060 -0.0615 0.0255)
+(-0.0030 -0.0615 0.0255)
+(0.0000 -0.0615 0.0255)
+(0.0030 -0.0615 0.0255)
+(0.0060 -0.0615 0.0255)
+(-0.0060 -0.0585 0.0255)
+(-0.0030 -0.0585 0.0255)
+(0.0000 -0.0585 0.0255)
+(0.0030 -0.0585 0.0255)
+(0.0060 -0.0585 0.0255)
+(-0.0060 -0.0555 0.0255)
+(-0.0030 -0.0555 0.0255)
+(0.0000 -0.0555 0.0255)
+(0.0030 -0.0555 0.0255)
+(0.0060 -0.0555 0.0255)
+(-0.0060 -0.0525 0.0255)
+(-0.0030 -0.0525 0.0255)
+(0.0000 -0.0525 0.0255)
+(0.0030 -0.0525 0.0255)
+(0.0060 -0.0525 0.0255)
+(-0.0060 -0.0495 0.0255)
+(-0.0030 -0.0495 0.0255)
+(0.0000 -0.0495 0.0255)
+(0.0030 -0.0495 0.0255)
+(0.0060 -0.0495 0.0255)
+(-0.0060 -0.0465 0.0255)
+(-0.0030 -0.0465 0.0255)
+(0.0000 -0.0465 0.0255)
+(0.0030 -0.0465 0.0255)
+(0.0060 -0.0465 0.0255)
+(-0.0060 -0.0435 0.0255)
+(-0.0030 -0.0435 0.0255)
+(0.0000 -0.0435 0.0255)
+(0.0030 -0.0435 0.0255)
+(0.0060 -0.0435 0.0255)
+(-0.0060 -0.0405 0.0255)
+(-0.0030 -0.0405 0.0255)
+(0.0000 -0.0405 0.0255)
+(0.0030 -0.0405 0.0255)
+(0.0060 -0.0405 0.0255)
+(-0.0060 -0.0375 0.0255)
+(-0.0030 -0.0375 0.0255)
+(0.0000 -0.0375 0.0255)
+(0.0030 -0.0375 0.0255)
+(0.0060 -0.0375 0.0255)
+(-0.0060 -0.0345 0.0255)
+(-0.0030 -0.0345 0.0255)
+(0.0000 -0.0345 0.0255)
+(0.0030 -0.0345 0.0255)
+(0.0060 -0.0345 0.0255)
+(-0.0060 -0.0315 0.0255)
+(-0.0030 -0.0315 0.0255)
+(0.0000 -0.0315 0.0255)
+(0.0030 -0.0315 0.0255)
+(0.0060 -0.0315 0.0255)
+(-0.0060 -0.0285 0.0255)
+(-0.0030 -0.0285 0.0255)
+(0.0000 -0.0285 0.0255)
+(0.0030 -0.0285 0.0255)
+(0.0060 -0.0285 0.0255)
+(-0.0060 -0.0255 0.0255)
+(-0.0030 -0.0255 0.0255)
+(0.0000 -0.0255 0.0255)
+(0.0030 -0.0255 0.0255)
+(0.0060 -0.0255 0.0255)
+(-0.0060 -0.0225 0.0255)
+(-0.0030 -0.0225 0.0255)
+(0.0000 -0.0225 0.0255)
+(0.0030 -0.0225 0.0255)
+(0.0060 -0.0225 0.0255)
+(-0.0060 -0.0195 0.0255)
+(-0.0030 -0.0195 0.0255)
+(0.0000 -0.0195 0.0255)
+(0.0030 -0.0195 0.0255)
+(0.0060 -0.0195 0.0255)
+(-0.0060 -0.0165 0.0255)
+(-0.0030 -0.0165 0.0255)
+(0.0000 -0.0165 0.0255)
+(0.0030 -0.0165 0.0255)
+(0.0060 -0.0165 0.0255)
+(-0.0060 -0.0135 0.0255)
+(-0.0030 -0.0135 0.0255)
+(0.0000 -0.0135 0.0255)
+(0.0030 -0.0135 0.0255)
+(0.0060 -0.0135 0.0255)
+(-0.0060 -0.0105 0.0255)
+(-0.0030 -0.0105 0.0255)
+(0.0000 -0.0105 0.0255)
+(0.0030 -0.0105 0.0255)
+(0.0060 -0.0105 0.0255)
+(-0.0060 -0.0075 0.0255)
+(-0.0030 -0.0075 0.0255)
+(0.0000 -0.0075 0.0255)
+(0.0030 -0.0075 0.0255)
+(0.0060 -0.0075 0.0255)
+(-0.0060 -0.0045 0.0255)
+(-0.0030 -0.0045 0.0255)
+(0.0000 -0.0045 0.0255)
+(0.0030 -0.0045 0.0255)
+(0.0060 -0.0045 0.0255)
+(-0.0060 -0.0015 0.0255)
+(-0.0030 -0.0015 0.0255)
+(0.0000 -0.0015 0.0255)
+(0.0030 -0.0015 0.0255)
+(0.0060 -0.0015 0.0255)
+(-0.0060 0.0015 0.0255)
+(-0.0030 0.0015 0.0255)
+(0.0000 0.0015 0.0255)
+(0.0030 0.0015 0.0255)
+(0.0060 0.0015 0.0255)
+(-0.0060 0.0045 0.0255)
+(-0.0030 0.0045 0.0255)
+(0.0000 0.0045 0.0255)
+(0.0030 0.0045 0.0255)
+(0.0060 0.0045 0.0255)
+(-0.0060 0.0075 0.0255)
+(-0.0030 0.0075 0.0255)
+(0.0000 0.0075 0.0255)
+(0.0030 0.0075 0.0255)
+(0.0060 0.0075 0.0255)
+(-0.0060 0.0105 0.0255)
+(-0.0030 0.0105 0.0255)
+(0.0000 0.0105 0.0255)
+(0.0030 0.0105 0.0255)
+(0.0060 0.0105 0.0255)
+(-0.0060 0.0135 0.0255)
+(-0.0030 0.0135 0.0255)
+(0.0000 0.0135 0.0255)
+(0.0030 0.0135 0.0255)
+(0.0060 0.0135 0.0255)
+(-0.0060 0.0165 0.0255)
+(-0.0030 0.0165 0.0255)
+(0.0000 0.0165 0.0255)
+(0.0030 0.0165 0.0255)
+(0.0060 0.0165 0.0255)
+(-0.0060 0.0195 0.0255)
+(-0.0030 0.0195 0.0255)
+(0.0000 0.0195 0.0255)
+(0.0030 0.0195 0.0255)
+(0.0060 0.0195 0.0255)
+(-0.0060 0.0225 0.0255)
+(-0.0030 0.0225 0.0255)
+(0.0000 0.0225 0.0255)
+(0.0030 0.0225 0.0255)
+(0.0060 0.0225 0.0255)
+(-0.0060 0.0255 0.0255)
+(-0.0030 0.0255 0.0255)
+(0.0000 0.0255 0.0255)
+(0.0030 0.0255 0.0255)
+(0.0060 0.0255 0.0255)
+(-0.0060 0.0285 0.0255)
+(-0.0030 0.0285 0.0255)
+(0.0000 0.0285 0.0255)
+(0.0030 0.0285 0.0255)
+(0.0060 0.0285 0.0255)
+(-0.0060 0.0315 0.0255)
+(-0.0030 0.0315 0.0255)
+(0.0000 0.0315 0.0255)
+(0.0030 0.0315 0.0255)
+(0.0060 0.0315 0.0255)
+(-0.0060 0.0345 0.0255)
+(-0.0030 0.0345 0.0255)
+(0.0000 0.0345 0.0255)
+(0.0030 0.0345 0.0255)
+(0.0060 0.0345 0.0255)
+(-0.0060 0.0375 0.0255)
+(-0.0030 0.0375 0.0255)
+(0.0000 0.0375 0.0255)
+(0.0030 0.0375 0.0255)
+(0.0060 0.0375 0.0255)
+(-0.0060 0.0405 0.0255)
+(-0.0030 0.0405 0.0255)
+(0.0000 0.0405 0.0255)
+(0.0030 0.0405 0.0255)
+(0.0060 0.0405 0.0255)
+(-0.0060 0.0435 0.0255)
+(-0.0030 0.0435 0.0255)
+(0.0000 0.0435 0.0255)
+(0.0030 0.0435 0.0255)
+(0.0060 0.0435 0.0255)
+(-0.0060 0.0465 0.0255)
+(-0.0030 0.0465 0.0255)
+(0.0000 0.0465 0.0255)
+(0.0030 0.0465 0.0255)
+(0.0060 0.0465 0.0255)
+(-0.0060 0.0495 0.0255)
+(-0.0030 0.0495 0.0255)
+(0.0000 0.0495 0.0255)
+(0.0030 0.0495 0.0255)
+(0.0060 0.0495 0.0255)
+(-0.0060 0.0525 0.0255)
+(-0.0030 0.0525 0.0255)
+(0.0000 0.0525 0.0255)
+(0.0030 0.0525 0.0255)
+(0.0060 0.0525 0.0255)
+(-0.0060 0.0555 0.0255)
+(-0.0030 0.0555 0.0255)
+(0.0000 0.0555 0.0255)
+(0.0030 0.0555 0.0255)
+(0.0060 0.0555 0.0255)
+(-0.0060 0.0585 0.0255)
+(-0.0030 0.0585 0.0255)
+(0.0000 0.0585 0.0255)
+(0.0030 0.0585 0.0255)
+(0.0060 0.0585 0.0255)
+(-0.0060 0.0615 0.0255)
+(-0.0030 0.0615 0.0255)
+(0.0000 0.0615 0.0255)
+(0.0030 0.0615 0.0255)
+(0.0060 0.0615 0.0255)
+(-0.0060 0.0645 0.0255)
+(-0.0030 0.0645 0.0255)
+(0.0000 0.0645 0.0255)
+(0.0030 0.0645 0.0255)
+(0.0060 0.0645 0.0255)
+(-0.0060 0.0675 0.0255)
+(-0.0030 0.0675 0.0255)
+(0.0000 0.0675 0.0255)
+(0.0030 0.0675 0.0255)
+(0.0060 0.0675 0.0255)
+(-0.0060 0.0705 0.0255)
+(-0.0030 0.0705 0.0255)
+(0.0000 0.0705 0.0255)
+(0.0030 0.0705 0.0255)
+(0.0060 0.0705 0.0255)
+(-0.0060 0.0735 0.0255)
+(-0.0030 0.0735 0.0255)
+(0.0000 0.0735 0.0255)
+(0.0030 0.0735 0.0255)
+(0.0060 0.0735 0.0255)
+(-0.0060 -0.0735 0.0285)
+(-0.0030 -0.0735 0.0285)
+(0.0000 -0.0735 0.0285)
+(0.0030 -0.0735 0.0285)
+(0.0060 -0.0735 0.0285)
+(-0.0060 -0.0705 0.0285)
+(-0.0030 -0.0705 0.0285)
+(0.0000 -0.0705 0.0285)
+(0.0030 -0.0705 0.0285)
+(0.0060 -0.0705 0.0285)
+(-0.0060 -0.0675 0.0285)
+(-0.0030 -0.0675 0.0285)
+(0.0000 -0.0675 0.0285)
+(0.0030 -0.0675 0.0285)
+(0.0060 -0.0675 0.0285)
+(-0.0060 -0.0645 0.0285)
+(-0.0030 -0.0645 0.0285)
+(0.0000 -0.0645 0.0285)
+(0.0030 -0.0645 0.0285)
+(0.0060 -0.0645 0.0285)
+(-0.0060 -0.0615 0.0285)
+(-0.0030 -0.0615 0.0285)
+(0.0000 -0.0615 0.0285)
+(0.0030 -0.0615 0.0285)
+(0.0060 -0.0615 0.0285)
+(-0.0060 -0.0585 0.0285)
+(-0.0030 -0.0585 0.0285)
+(0.0000 -0.0585 0.0285)
+(0.0030 -0.0585 0.0285)
+(0.0060 -0.0585 0.0285)
+(-0.0060 -0.0555 0.0285)
+(-0.0030 -0.0555 0.0285)
+(0.0000 -0.0555 0.0285)
+(0.0030 -0.0555 0.0285)
+(0.0060 -0.0555 0.0285)
+(-0.0060 -0.0525 0.0285)
+(-0.0030 -0.0525 0.0285)
+(0.0000 -0.0525 0.0285)
+(0.0030 -0.0525 0.0285)
+(0.0060 -0.0525 0.0285)
+(-0.0060 -0.0495 0.0285)
+(-0.0030 -0.0495 0.0285)
+(0.0000 -0.0495 0.0285)
+(0.0030 -0.0495 0.0285)
+(0.0060 -0.0495 0.0285)
+(-0.0060 -0.0465 0.0285)
+(-0.0030 -0.0465 0.0285)
+(0.0000 -0.0465 0.0285)
+(0.0030 -0.0465 0.0285)
+(0.0060 -0.0465 0.0285)
+(-0.0060 -0.0435 0.0285)
+(-0.0030 -0.0435 0.0285)
+(0.0000 -0.0435 0.0285)
+(0.0030 -0.0435 0.0285)
+(0.0060 -0.0435 0.0285)
+(-0.0060 -0.0405 0.0285)
+(-0.0030 -0.0405 0.0285)
+(0.0000 -0.0405 0.0285)
+(0.0030 -0.0405 0.0285)
+(0.0060 -0.0405 0.0285)
+(-0.0060 -0.0375 0.0285)
+(-0.0030 -0.0375 0.0285)
+(0.0000 -0.0375 0.0285)
+(0.0030 -0.0375 0.0285)
+(0.0060 -0.0375 0.0285)
+(-0.0060 -0.0345 0.0285)
+(-0.0030 -0.0345 0.0285)
+(0.0000 -0.0345 0.0285)
+(0.0030 -0.0345 0.0285)
+(0.0060 -0.0345 0.0285)
+(-0.0060 -0.0315 0.0285)
+(-0.0030 -0.0315 0.0285)
+(0.0000 -0.0315 0.0285)
+(0.0030 -0.0315 0.0285)
+(0.0060 -0.0315 0.0285)
+(-0.0060 -0.0285 0.0285)
+(-0.0030 -0.0285 0.0285)
+(0.0000 -0.0285 0.0285)
+(0.0030 -0.0285 0.0285)
+(0.0060 -0.0285 0.0285)
+(-0.0060 -0.0255 0.0285)
+(-0.0030 -0.0255 0.0285)
+(0.0000 -0.0255 0.0285)
+(0.0030 -0.0255 0.0285)
+(0.0060 -0.0255 0.0285)
+(-0.0060 -0.0225 0.0285)
+(-0.0030 -0.0225 0.0285)
+(0.0000 -0.0225 0.0285)
+(0.0030 -0.0225 0.0285)
+(0.0060 -0.0225 0.0285)
+(-0.0060 -0.0195 0.0285)
+(-0.0030 -0.0195 0.0285)
+(0.0000 -0.0195 0.0285)
+(0.0030 -0.0195 0.0285)
+(0.0060 -0.0195 0.0285)
+(-0.0060 -0.0165 0.0285)
+(-0.0030 -0.0165 0.0285)
+(0.0000 -0.0165 0.0285)
+(0.0030 -0.0165 0.0285)
+(0.0060 -0.0165 0.0285)
+(-0.0060 -0.0135 0.0285)
+(-0.0030 -0.0135 0.0285)
+(0.0000 -0.0135 0.0285)
+(0.0030 -0.0135 0.0285)
+(0.0060 -0.0135 0.0285)
+(-0.0060 -0.0105 0.0285)
+(-0.0030 -0.0105 0.0285)
+(0.0000 -0.0105 0.0285)
+(0.0030 -0.0105 0.0285)
+(0.0060 -0.0105 0.0285)
+(-0.0060 -0.0075 0.0285)
+(-0.0030 -0.0075 0.0285)
+(0.0000 -0.0075 0.0285)
+(0.0030 -0.0075 0.0285)
+(0.0060 -0.0075 0.0285)
+(-0.0060 -0.0045 0.0285)
+(-0.0030 -0.0045 0.0285)
+(0.0000 -0.0045 0.0285)
+(0.0030 -0.0045 0.0285)
+(0.0060 -0.0045 0.0285)
+(-0.0060 -0.0015 0.0285)
+(-0.0030 -0.0015 0.0285)
+(0.0000 -0.0015 0.0285)
+(0.0030 -0.0015 0.0285)
+(0.0060 -0.0015 0.0285)
+(-0.0060 0.0015 0.0285)
+(-0.0030 0.0015 0.0285)
+(0.0000 0.0015 0.0285)
+(0.0030 0.0015 0.0285)
+(0.0060 0.0015 0.0285)
+(-0.0060 0.0045 0.0285)
+(-0.0030 0.0045 0.0285)
+(0.0000 0.0045 0.0285)
+(0.0030 0.0045 0.0285)
+(0.0060 0.0045 0.0285)
+(-0.0060 0.0075 0.0285)
+(-0.0030 0.0075 0.0285)
+(0.0000 0.0075 0.0285)
+(0.0030 0.0075 0.0285)
+(0.0060 0.0075 0.0285)
+(-0.0060 0.0105 0.0285)
+(-0.0030 0.0105 0.0285)
+(0.0000 0.0105 0.0285)
+(0.0030 0.0105 0.0285)
+(0.0060 0.0105 0.0285)
+(-0.0060 0.0135 0.0285)
+(-0.0030 0.0135 0.0285)
+(0.0000 0.0135 0.0285)
+(0.0030 0.0135 0.0285)
+(0.0060 0.0135 0.0285)
+(-0.0060 0.0165 0.0285)
+(-0.0030 0.0165 0.0285)
+(0.0000 0.0165 0.0285)
+(0.0030 0.0165 0.0285)
+(0.0060 0.0165 0.0285)
+(-0.0060 0.0195 0.0285)
+(-0.0030 0.0195 0.0285)
+(0.0000 0.0195 0.0285)
+(0.0030 0.0195 0.0285)
+(0.0060 0.0195 0.0285)
+(-0.0060 0.0225 0.0285)
+(-0.0030 0.0225 0.0285)
+(0.0000 0.0225 0.0285)
+(0.0030 0.0225 0.0285)
+(0.0060 0.0225 0.0285)
+(-0.0060 0.0255 0.0285)
+(-0.0030 0.0255 0.0285)
+(0.0000 0.0255 0.0285)
+(0.0030 0.0255 0.0285)
+(0.0060 0.0255 0.0285)
+(-0.0060 0.0285 0.0285)
+(-0.0030 0.0285 0.0285)
+(0.0000 0.0285 0.0285)
+(0.0030 0.0285 0.0285)
+(0.0060 0.0285 0.0285)
+(-0.0060 0.0315 0.0285)
+(-0.0030 0.0315 0.0285)
+(0.0000 0.0315 0.0285)
+(0.0030 0.0315 0.0285)
+(0.0060 0.0315 0.0285)
+(-0.0060 0.0345 0.0285)
+(-0.0030 0.0345 0.0285)
+(0.0000 0.0345 0.0285)
+(0.0030 0.0345 0.0285)
+(0.0060 0.0345 0.0285)
+(-0.0060 0.0375 0.0285)
+(-0.0030 0.0375 0.0285)
+(0.0000 0.0375 0.0285)
+(0.0030 0.0375 0.0285)
+(0.0060 0.0375 0.0285)
+(-0.0060 0.0405 0.0285)
+(-0.0030 0.0405 0.0285)
+(0.0000 0.0405 0.0285)
+(0.0030 0.0405 0.0285)
+(0.0060 0.0405 0.0285)
+(-0.0060 0.0435 0.0285)
+(-0.0030 0.0435 0.0285)
+(0.0000 0.0435 0.0285)
+(0.0030 0.0435 0.0285)
+(0.0060 0.0435 0.0285)
+(-0.0060 0.0465 0.0285)
+(-0.0030 0.0465 0.0285)
+(0.0000 0.0465 0.0285)
+(0.0030 0.0465 0.0285)
+(0.0060 0.0465 0.0285)
+(-0.0060 0.0495 0.0285)
+(-0.0030 0.0495 0.0285)
+(0.0000 0.0495 0.0285)
+(0.0030 0.0495 0.0285)
+(0.0060 0.0495 0.0285)
+(-0.0060 0.0525 0.0285)
+(-0.0030 0.0525 0.0285)
+(0.0000 0.0525 0.0285)
+(0.0030 0.0525 0.0285)
+(0.0060 0.0525 0.0285)
+(-0.0060 0.0555 0.0285)
+(-0.0030 0.0555 0.0285)
+(0.0000 0.0555 0.0285)
+(0.0030 0.0555 0.0285)
+(0.0060 0.0555 0.0285)
+(-0.0060 0.0585 0.0285)
+(-0.0030 0.0585 0.0285)
+(0.0000 0.0585 0.0285)
+(0.0030 0.0585 0.0285)
+(0.0060 0.0585 0.0285)
+(-0.0060 0.0615 0.0285)
+(-0.0030 0.0615 0.0285)
+(0.0000 0.0615 0.0285)
+(0.0030 0.0615 0.0285)
+(0.0060 0.0615 0.0285)
+(-0.0060 0.0645 0.0285)
+(-0.0030 0.0645 0.0285)
+(0.0000 0.0645 0.0285)
+(0.0030 0.0645 0.0285)
+(0.0060 0.0645 0.0285)
+(-0.0060 0.0675 0.0285)
+(-0.0030 0.0675 0.0285)
+(0.0000 0.0675 0.0285)
+(0.0030 0.0675 0.0285)
+(0.0060 0.0675 0.0285)
+(-0.0060 0.0705 0.0285)
+(-0.0030 0.0705 0.0285)
+(0.0000 0.0705 0.0285)
+(0.0030 0.0705 0.0285)
+(0.0060 0.0705 0.0285)
+(-0.0060 0.0735 0.0285)
+(-0.0030 0.0735 0.0285)
+(0.0000 0.0735 0.0285)
+(0.0030 0.0735 0.0285)
+(0.0060 0.0735 0.0285)
+(-0.0060 -0.0735 0.0315)
+(-0.0030 -0.0735 0.0315)
+(0.0000 -0.0735 0.0315)
+(0.0030 -0.0735 0.0315)
+(0.0060 -0.0735 0.0315)
+(-0.0060 -0.0705 0.0315)
+(-0.0030 -0.0705 0.0315)
+(0.0000 -0.0705 0.0315)
+(0.0030 -0.0705 0.0315)
+(0.0060 -0.0705 0.0315)
+(-0.0060 -0.0675 0.0315)
+(-0.0030 -0.0675 0.0315)
+(0.0000 -0.0675 0.0315)
+(0.0030 -0.0675 0.0315)
+(0.0060 -0.0675 0.0315)
+(-0.0060 -0.0645 0.0315)
+(-0.0030 -0.0645 0.0315)
+(0.0000 -0.0645 0.0315)
+(0.0030 -0.0645 0.0315)
+(0.0060 -0.0645 0.0315)
+(-0.0060 -0.0615 0.0315)
+(-0.0030 -0.0615 0.0315)
+(0.0000 -0.0615 0.0315)
+(0.0030 -0.0615 0.0315)
+(0.0060 -0.0615 0.0315)
+(-0.0060 -0.0585 0.0315)
+(-0.0030 -0.0585 0.0315)
+(0.0000 -0.0585 0.0315)
+(0.0030 -0.0585 0.0315)
+(0.0060 -0.0585 0.0315)
+(-0.0060 -0.0555 0.0315)
+(-0.0030 -0.0555 0.0315)
+(0.0000 -0.0555 0.0315)
+(0.0030 -0.0555 0.0315)
+(0.0060 -0.0555 0.0315)
+(-0.0060 -0.0525 0.0315)
+(-0.0030 -0.0525 0.0315)
+(0.0000 -0.0525 0.0315)
+(0.0030 -0.0525 0.0315)
+(0.0060 -0.0525 0.0315)
+(-0.0060 -0.0495 0.0315)
+(-0.0030 -0.0495 0.0315)
+(0.0000 -0.0495 0.0315)
+(0.0030 -0.0495 0.0315)
+(0.0060 -0.0495 0.0315)
+(-0.0060 -0.0465 0.0315)
+(-0.0030 -0.0465 0.0315)
+(0.0000 -0.0465 0.0315)
+(0.0030 -0.0465 0.0315)
+(0.0060 -0.0465 0.0315)
+(-0.0060 -0.0435 0.0315)
+(-0.0030 -0.0435 0.0315)
+(0.0000 -0.0435 0.0315)
+(0.0030 -0.0435 0.0315)
+(0.0060 -0.0435 0.0315)
+(-0.0060 -0.0405 0.0315)
+(-0.0030 -0.0405 0.0315)
+(0.0000 -0.0405 0.0315)
+(0.0030 -0.0405 0.0315)
+(0.0060 -0.0405 0.0315)
+(-0.0060 -0.0375 0.0315)
+(-0.0030 -0.0375 0.0315)
+(0.0000 -0.0375 0.0315)
+(0.0030 -0.0375 0.0315)
+(0.0060 -0.0375 0.0315)
+(-0.0060 -0.0345 0.0315)
+(-0.0030 -0.0345 0.0315)
+(0.0000 -0.0345 0.0315)
+(0.0030 -0.0345 0.0315)
+(0.0060 -0.0345 0.0315)
+(-0.0060 -0.0315 0.0315)
+(-0.0030 -0.0315 0.0315)
+(0.0000 -0.0315 0.0315)
+(0.0030 -0.0315 0.0315)
+(0.0060 -0.0315 0.0315)
+(-0.0060 -0.0285 0.0315)
+(-0.0030 -0.0285 0.0315)
+(0.0000 -0.0285 0.0315)
+(0.0030 -0.0285 0.0315)
+(0.0060 -0.0285 0.0315)
+(-0.0060 -0.0255 0.0315)
+(-0.0030 -0.0255 0.0315)
+(0.0000 -0.0255 0.0315)
+(0.0030 -0.0255 0.0315)
+(0.0060 -0.0255 0.0315)
+(-0.0060 -0.0225 0.0315)
+(-0.0030 -0.0225 0.0315)
+(0.0000 -0.0225 0.0315)
+(0.0030 -0.0225 0.0315)
+(0.0060 -0.0225 0.0315)
+(-0.0060 -0.0195 0.0315)
+(-0.0030 -0.0195 0.0315)
+(0.0000 -0.0195 0.0315)
+(0.0030 -0.0195 0.0315)
+(0.0060 -0.0195 0.0315)
+(-0.0060 -0.0165 0.0315)
+(-0.0030 -0.0165 0.0315)
+(0.0000 -0.0165 0.0315)
+(0.0030 -0.0165 0.0315)
+(0.0060 -0.0165 0.0315)
+(-0.0060 -0.0135 0.0315)
+(-0.0030 -0.0135 0.0315)
+(0.0000 -0.0135 0.0315)
+(0.0030 -0.0135 0.0315)
+(0.0060 -0.0135 0.0315)
+(-0.0060 -0.0105 0.0315)
+(-0.0030 -0.0105 0.0315)
+(0.0000 -0.0105 0.0315)
+(0.0030 -0.0105 0.0315)
+(0.0060 -0.0105 0.0315)
+(-0.0060 -0.0075 0.0315)
+(-0.0030 -0.0075 0.0315)
+(0.0000 -0.0075 0.0315)
+(0.0030 -0.0075 0.0315)
+(0.0060 -0.0075 0.0315)
+(-0.0060 -0.0045 0.0315)
+(-0.0030 -0.0045 0.0315)
+(0.0000 -0.0045 0.0315)
+(0.0030 -0.0045 0.0315)
+(0.0060 -0.0045 0.0315)
+(-0.0060 -0.0015 0.0315)
+(-0.0030 -0.0015 0.0315)
+(0.0000 -0.0015 0.0315)
+(0.0030 -0.0015 0.0315)
+(0.0060 -0.0015 0.0315)
+(-0.0060 0.0015 0.0315)
+(-0.0030 0.0015 0.0315)
+(0.0000 0.0015 0.0315)
+(0.0030 0.0015 0.0315)
+(0.0060 0.0015 0.0315)
+(-0.0060 0.0045 0.0315)
+(-0.0030 0.0045 0.0315)
+(0.0000 0.0045 0.0315)
+(0.0030 0.0045 0.0315)
+(0.0060 0.0045 0.0315)
+(-0.0060 0.0075 0.0315)
+(-0.0030 0.0075 0.0315)
+(0.0000 0.0075 0.0315)
+(0.0030 0.0075 0.0315)
+(0.0060 0.0075 0.0315)
+(-0.0060 0.0105 0.0315)
+(-0.0030 0.0105 0.0315)
+(0.0000 0.0105 0.0315)
+(0.0030 0.0105 0.0315)
+(0.0060 0.0105 0.0315)
+(-0.0060 0.0135 0.0315)
+(-0.0030 0.0135 0.0315)
+(0.0000 0.0135 0.0315)
+(0.0030 0.0135 0.0315)
+(0.0060 0.0135 0.0315)
+(-0.0060 0.0165 0.0315)
+(-0.0030 0.0165 0.0315)
+(0.0000 0.0165 0.0315)
+(0.0030 0.0165 0.0315)
+(0.0060 0.0165 0.0315)
+(-0.0060 0.0195 0.0315)
+(-0.0030 0.0195 0.0315)
+(0.0000 0.0195 0.0315)
+(0.0030 0.0195 0.0315)
+(0.0060 0.0195 0.0315)
+(-0.0060 0.0225 0.0315)
+(-0.0030 0.0225 0.0315)
+(0.0000 0.0225 0.0315)
+(0.0030 0.0225 0.0315)
+(0.0060 0.0225 0.0315)
+(-0.0060 0.0255 0.0315)
+(-0.0030 0.0255 0.0315)
+(0.0000 0.0255 0.0315)
+(0.0030 0.0255 0.0315)
+(0.0060 0.0255 0.0315)
+(-0.0060 0.0285 0.0315)
+(-0.0030 0.0285 0.0315)
+(0.0000 0.0285 0.0315)
+(0.0030 0.0285 0.0315)
+(0.0060 0.0285 0.0315)
+(-0.0060 0.0315 0.0315)
+(-0.0030 0.0315 0.0315)
+(0.0000 0.0315 0.0315)
+(0.0030 0.0315 0.0315)
+(0.0060 0.0315 0.0315)
+(-0.0060 0.0345 0.0315)
+(-0.0030 0.0345 0.0315)
+(0.0000 0.0345 0.0315)
+(0.0030 0.0345 0.0315)
+(0.0060 0.0345 0.0315)
+(-0.0060 0.0375 0.0315)
+(-0.0030 0.0375 0.0315)
+(0.0000 0.0375 0.0315)
+(0.0030 0.0375 0.0315)
+(0.0060 0.0375 0.0315)
+(-0.0060 0.0405 0.0315)
+(-0.0030 0.0405 0.0315)
+(0.0000 0.0405 0.0315)
+(0.0030 0.0405 0.0315)
+(0.0060 0.0405 0.0315)
+(-0.0060 0.0435 0.0315)
+(-0.0030 0.0435 0.0315)
+(0.0000 0.0435 0.0315)
+(0.0030 0.0435 0.0315)
+(0.0060 0.0435 0.0315)
+(-0.0060 0.0465 0.0315)
+(-0.0030 0.0465 0.0315)
+(0.0000 0.0465 0.0315)
+(0.0030 0.0465 0.0315)
+(0.0060 0.0465 0.0315)
+(-0.0060 0.0495 0.0315)
+(-0.0030 0.0495 0.0315)
+(0.0000 0.0495 0.0315)
+(0.0030 0.0495 0.0315)
+(0.0060 0.0495 0.0315)
+(-0.0060 0.0525 0.0315)
+(-0.0030 0.0525 0.0315)
+(0.0000 0.0525 0.0315)
+(0.0030 0.0525 0.0315)
+(0.0060 0.0525 0.0315)
+(-0.0060 0.0555 0.0315)
+(-0.0030 0.0555 0.0315)
+(0.0000 0.0555 0.0315)
+(0.0030 0.0555 0.0315)
+(0.0060 0.0555 0.0315)
+(-0.0060 0.0585 0.0315)
+(-0.0030 0.0585 0.0315)
+(0.0000 0.0585 0.0315)
+(0.0030 0.0585 0.0315)
+(0.0060 0.0585 0.0315)
+(-0.0060 0.0615 0.0315)
+(-0.0030 0.0615 0.0315)
+(0.0000 0.0615 0.0315)
+(0.0030 0.0615 0.0315)
+(0.0060 0.0615 0.0315)
+(-0.0060 0.0645 0.0315)
+(-0.0030 0.0645 0.0315)
+(0.0000 0.0645 0.0315)
+(0.0030 0.0645 0.0315)
+(0.0060 0.0645 0.0315)
+(-0.0060 0.0675 0.0315)
+(-0.0030 0.0675 0.0315)
+(0.0000 0.0675 0.0315)
+(0.0030 0.0675 0.0315)
+(0.0060 0.0675 0.0315)
+(-0.0060 0.0705 0.0315)
+(-0.0030 0.0705 0.0315)
+(0.0000 0.0705 0.0315)
+(0.0030 0.0705 0.0315)
+(0.0060 0.0705 0.0315)
+(-0.0060 0.0735 0.0315)
+(-0.0030 0.0735 0.0315)
+(0.0000 0.0735 0.0315)
+(0.0030 0.0735 0.0315)
+(0.0060 0.0735 0.0315)
+(-0.0060 -0.0735 0.0345)
+(-0.0030 -0.0735 0.0345)
+(0.0000 -0.0735 0.0345)
+(0.0030 -0.0735 0.0345)
+(0.0060 -0.0735 0.0345)
+(-0.0060 -0.0705 0.0345)
+(-0.0030 -0.0705 0.0345)
+(0.0000 -0.0705 0.0345)
+(0.0030 -0.0705 0.0345)
+(0.0060 -0.0705 0.0345)
+(-0.0060 -0.0675 0.0345)
+(-0.0030 -0.0675 0.0345)
+(0.0000 -0.0675 0.0345)
+(0.0030 -0.0675 0.0345)
+(0.0060 -0.0675 0.0345)
+(-0.0060 -0.0645 0.0345)
+(-0.0030 -0.0645 0.0345)
+(0.0000 -0.0645 0.0345)
+(0.0030 -0.0645 0.0345)
+(0.0060 -0.0645 0.0345)
+(-0.0060 -0.0615 0.0345)
+(-0.0030 -0.0615 0.0345)
+(0.0000 -0.0615 0.0345)
+(0.0030 -0.0615 0.0345)
+(0.0060 -0.0615 0.0345)
+(-0.0060 -0.0585 0.0345)
+(-0.0030 -0.0585 0.0345)
+(0.0000 -0.0585 0.0345)
+(0.0030 -0.0585 0.0345)
+(0.0060 -0.0585 0.0345)
+(-0.0060 -0.0555 0.0345)
+(-0.0030 -0.0555 0.0345)
+(0.0000 -0.0555 0.0345)
+(0.0030 -0.0555 0.0345)
+(0.0060 -0.0555 0.0345)
+(-0.0060 -0.0525 0.0345)
+(-0.0030 -0.0525 0.0345)
+(0.0000 -0.0525 0.0345)
+(0.0030 -0.0525 0.0345)
+(0.0060 -0.0525 0.0345)
+(-0.0060 -0.0495 0.0345)
+(-0.0030 -0.0495 0.0345)
+(0.0000 -0.0495 0.0345)
+(0.0030 -0.0495 0.0345)
+(0.0060 -0.0495 0.0345)
+(-0.0060 -0.0465 0.0345)
+(-0.0030 -0.0465 0.0345)
+(0.0000 -0.0465 0.0345)
+(0.0030 -0.0465 0.0345)
+(0.0060 -0.0465 0.0345)
+(-0.0060 -0.0435 0.0345)
+(-0.0030 -0.0435 0.0345)
+(0.0000 -0.0435 0.0345)
+(0.0030 -0.0435 0.0345)
+(0.0060 -0.0435 0.0345)
+(-0.0060 -0.0405 0.0345)
+(-0.0030 -0.0405 0.0345)
+(0.0000 -0.0405 0.0345)
+(0.0030 -0.0405 0.0345)
+(0.0060 -0.0405 0.0345)
+(-0.0060 -0.0375 0.0345)
+(-0.0030 -0.0375 0.0345)
+(0.0000 -0.0375 0.0345)
+(0.0030 -0.0375 0.0345)
+(0.0060 -0.0375 0.0345)
+(-0.0060 -0.0345 0.0345)
+(-0.0030 -0.0345 0.0345)
+(0.0000 -0.0345 0.0345)
+(0.0030 -0.0345 0.0345)
+(0.0060 -0.0345 0.0345)
+(-0.0060 -0.0315 0.0345)
+(-0.0030 -0.0315 0.0345)
+(0.0000 -0.0315 0.0345)
+(0.0030 -0.0315 0.0345)
+(0.0060 -0.0315 0.0345)
+(-0.0060 -0.0285 0.0345)
+(-0.0030 -0.0285 0.0345)
+(0.0000 -0.0285 0.0345)
+(0.0030 -0.0285 0.0345)
+(0.0060 -0.0285 0.0345)
+(-0.0060 -0.0255 0.0345)
+(-0.0030 -0.0255 0.0345)
+(0.0000 -0.0255 0.0345)
+(0.0030 -0.0255 0.0345)
+(0.0060 -0.0255 0.0345)
+(-0.0060 -0.0225 0.0345)
+(-0.0030 -0.0225 0.0345)
+(0.0000 -0.0225 0.0345)
+(0.0030 -0.0225 0.0345)
+(0.0060 -0.0225 0.0345)
+(-0.0060 -0.0195 0.0345)
+(-0.0030 -0.0195 0.0345)
+(0.0000 -0.0195 0.0345)
+(0.0030 -0.0195 0.0345)
+(0.0060 -0.0195 0.0345)
+(-0.0060 -0.0165 0.0345)
+(-0.0030 -0.0165 0.0345)
+(0.0000 -0.0165 0.0345)
+(0.0030 -0.0165 0.0345)
+(0.0060 -0.0165 0.0345)
+(-0.0060 -0.0135 0.0345)
+(-0.0030 -0.0135 0.0345)
+(0.0000 -0.0135 0.0345)
+(0.0030 -0.0135 0.0345)
+(0.0060 -0.0135 0.0345)
+(-0.0060 -0.0105 0.0345)
+(-0.0030 -0.0105 0.0345)
+(0.0000 -0.0105 0.0345)
+(0.0030 -0.0105 0.0345)
+(0.0060 -0.0105 0.0345)
+(-0.0060 -0.0075 0.0345)
+(-0.0030 -0.0075 0.0345)
+(0.0000 -0.0075 0.0345)
+(0.0030 -0.0075 0.0345)
+(0.0060 -0.0075 0.0345)
+(-0.0060 -0.0045 0.0345)
+(-0.0030 -0.0045 0.0345)
+(0.0000 -0.0045 0.0345)
+(0.0030 -0.0045 0.0345)
+(0.0060 -0.0045 0.0345)
+(-0.0060 -0.0015 0.0345)
+(-0.0030 -0.0015 0.0345)
+(0.0000 -0.0015 0.0345)
+(0.0030 -0.0015 0.0345)
+(0.0060 -0.0015 0.0345)
+(-0.0060 0.0015 0.0345)
+(-0.0030 0.0015 0.0345)
+(0.0000 0.0015 0.0345)
+(0.0030 0.0015 0.0345)
+(0.0060 0.0015 0.0345)
+(-0.0060 0.0045 0.0345)
+(-0.0030 0.0045 0.0345)
+(0.0000 0.0045 0.0345)
+(0.0030 0.0045 0.0345)
+(0.0060 0.0045 0.0345)
+(-0.0060 0.0075 0.0345)
+(-0.0030 0.0075 0.0345)
+(0.0000 0.0075 0.0345)
+(0.0030 0.0075 0.0345)
+(0.0060 0.0075 0.0345)
+(-0.0060 0.0105 0.0345)
+(-0.0030 0.0105 0.0345)
+(0.0000 0.0105 0.0345)
+(0.0030 0.0105 0.0345)
+(0.0060 0.0105 0.0345)
+(-0.0060 0.0135 0.0345)
+(-0.0030 0.0135 0.0345)
+(0.0000 0.0135 0.0345)
+(0.0030 0.0135 0.0345)
+(0.0060 0.0135 0.0345)
+(-0.0060 0.0165 0.0345)
+(-0.0030 0.0165 0.0345)
+(0.0000 0.0165 0.0345)
+(0.0030 0.0165 0.0345)
+(0.0060 0.0165 0.0345)
+(-0.0060 0.0195 0.0345)
+(-0.0030 0.0195 0.0345)
+(0.0000 0.0195 0.0345)
+(0.0030 0.0195 0.0345)
+(0.0060 0.0195 0.0345)
+(-0.0060 0.0225 0.0345)
+(-0.0030 0.0225 0.0345)
+(0.0000 0.0225 0.0345)
+(0.0030 0.0225 0.0345)
+(0.0060 0.0225 0.0345)
+(-0.0060 0.0255 0.0345)
+(-0.0030 0.0255 0.0345)
+(0.0000 0.0255 0.0345)
+(0.0030 0.0255 0.0345)
+(0.0060 0.0255 0.0345)
+(-0.0060 0.0285 0.0345)
+(-0.0030 0.0285 0.0345)
+(0.0000 0.0285 0.0345)
+(0.0030 0.0285 0.0345)
+(0.0060 0.0285 0.0345)
+(-0.0060 0.0315 0.0345)
+(-0.0030 0.0315 0.0345)
+(0.0000 0.0315 0.0345)
+(0.0030 0.0315 0.0345)
+(0.0060 0.0315 0.0345)
+(-0.0060 0.0345 0.0345)
+(-0.0030 0.0345 0.0345)
+(0.0000 0.0345 0.0345)
+(0.0030 0.0345 0.0345)
+(0.0060 0.0345 0.0345)
+(-0.0060 0.0375 0.0345)
+(-0.0030 0.0375 0.0345)
+(0.0000 0.0375 0.0345)
+(0.0030 0.0375 0.0345)
+(0.0060 0.0375 0.0345)
+(-0.0060 0.0405 0.0345)
+(-0.0030 0.0405 0.0345)
+(0.0000 0.0405 0.0345)
+(0.0030 0.0405 0.0345)
+(0.0060 0.0405 0.0345)
+(-0.0060 0.0435 0.0345)
+(-0.0030 0.0435 0.0345)
+(0.0000 0.0435 0.0345)
+(0.0030 0.0435 0.0345)
+(0.0060 0.0435 0.0345)
+(-0.0060 0.0465 0.0345)
+(-0.0030 0.0465 0.0345)
+(0.0000 0.0465 0.0345)
+(0.0030 0.0465 0.0345)
+(0.0060 0.0465 0.0345)
+(-0.0060 0.0495 0.0345)
+(-0.0030 0.0495 0.0345)
+(0.0000 0.0495 0.0345)
+(0.0030 0.0495 0.0345)
+(0.0060 0.0495 0.0345)
+(-0.0060 0.0525 0.0345)
+(-0.0030 0.0525 0.0345)
+(0.0000 0.0525 0.0345)
+(0.0030 0.0525 0.0345)
+(0.0060 0.0525 0.0345)
+(-0.0060 0.0555 0.0345)
+(-0.0030 0.0555 0.0345)
+(0.0000 0.0555 0.0345)
+(0.0030 0.0555 0.0345)
+(0.0060 0.0555 0.0345)
+(-0.0060 0.0585 0.0345)
+(-0.0030 0.0585 0.0345)
+(0.0000 0.0585 0.0345)
+(0.0030 0.0585 0.0345)
+(0.0060 0.0585 0.0345)
+(-0.0060 0.0615 0.0345)
+(-0.0030 0.0615 0.0345)
+(0.0000 0.0615 0.0345)
+(0.0030 0.0615 0.0345)
+(0.0060 0.0615 0.0345)
+(-0.0060 0.0645 0.0345)
+(-0.0030 0.0645 0.0345)
+(0.0000 0.0645 0.0345)
+(0.0030 0.0645 0.0345)
+(0.0060 0.0645 0.0345)
+(-0.0060 0.0675 0.0345)
+(-0.0030 0.0675 0.0345)
+(0.0000 0.0675 0.0345)
+(0.0030 0.0675 0.0345)
+(0.0060 0.0675 0.0345)
+(-0.0060 0.0705 0.0345)
+(-0.0030 0.0705 0.0345)
+(0.0000 0.0705 0.0345)
+(0.0030 0.0705 0.0345)
+(0.0060 0.0705 0.0345)
+(-0.0060 0.0735 0.0345)
+(-0.0030 0.0735 0.0345)
+(0.0000 0.0735 0.0345)
+(0.0030 0.0735 0.0345)
+(0.0060 0.0735 0.0345)
+(-0.0060 -0.0735 0.0375)
+(-0.0030 -0.0735 0.0375)
+(0.0000 -0.0735 0.0375)
+(0.0030 -0.0735 0.0375)
+(0.0060 -0.0735 0.0375)
+(-0.0060 -0.0705 0.0375)
+(-0.0030 -0.0705 0.0375)
+(0.0000 -0.0705 0.0375)
+(0.0030 -0.0705 0.0375)
+(0.0060 -0.0705 0.0375)
+(-0.0060 -0.0675 0.0375)
+(-0.0030 -0.0675 0.0375)
+(0.0000 -0.0675 0.0375)
+(0.0030 -0.0675 0.0375)
+(0.0060 -0.0675 0.0375)
+(-0.0060 -0.0645 0.0375)
+(-0.0030 -0.0645 0.0375)
+(0.0000 -0.0645 0.0375)
+(0.0030 -0.0645 0.0375)
+(0.0060 -0.0645 0.0375)
+(-0.0060 -0.0615 0.0375)
+(-0.0030 -0.0615 0.0375)
+(0.0000 -0.0615 0.0375)
+(0.0030 -0.0615 0.0375)
+(0.0060 -0.0615 0.0375)
+(-0.0060 -0.0585 0.0375)
+(-0.0030 -0.0585 0.0375)
+(0.0000 -0.0585 0.0375)
+(0.0030 -0.0585 0.0375)
+(0.0060 -0.0585 0.0375)
+(-0.0060 -0.0555 0.0375)
+(-0.0030 -0.0555 0.0375)
+(0.0000 -0.0555 0.0375)
+(0.0030 -0.0555 0.0375)
+(0.0060 -0.0555 0.0375)
+(-0.0060 -0.0525 0.0375)
+(-0.0030 -0.0525 0.0375)
+(0.0000 -0.0525 0.0375)
+(0.0030 -0.0525 0.0375)
+(0.0060 -0.0525 0.0375)
+(-0.0060 -0.0495 0.0375)
+(-0.0030 -0.0495 0.0375)
+(0.0000 -0.0495 0.0375)
+(0.0030 -0.0495 0.0375)
+(0.0060 -0.0495 0.0375)
+(-0.0060 -0.0465 0.0375)
+(-0.0030 -0.0465 0.0375)
+(0.0000 -0.0465 0.0375)
+(0.0030 -0.0465 0.0375)
+(0.0060 -0.0465 0.0375)
+(-0.0060 -0.0435 0.0375)
+(-0.0030 -0.0435 0.0375)
+(0.0000 -0.0435 0.0375)
+(0.0030 -0.0435 0.0375)
+(0.0060 -0.0435 0.0375)
+(-0.0060 -0.0405 0.0375)
+(-0.0030 -0.0405 0.0375)
+(0.0000 -0.0405 0.0375)
+(0.0030 -0.0405 0.0375)
+(0.0060 -0.0405 0.0375)
+(-0.0060 -0.0375 0.0375)
+(-0.0030 -0.0375 0.0375)
+(0.0000 -0.0375 0.0375)
+(0.0030 -0.0375 0.0375)
+(0.0060 -0.0375 0.0375)
+(-0.0060 -0.0345 0.0375)
+(-0.0030 -0.0345 0.0375)
+(0.0000 -0.0345 0.0375)
+(0.0030 -0.0345 0.0375)
+(0.0060 -0.0345 0.0375)
+(-0.0060 -0.0315 0.0375)
+(-0.0030 -0.0315 0.0375)
+(0.0000 -0.0315 0.0375)
+(0.0030 -0.0315 0.0375)
+(0.0060 -0.0315 0.0375)
+(-0.0060 -0.0285 0.0375)
+(-0.0030 -0.0285 0.0375)
+(0.0000 -0.0285 0.0375)
+(0.0030 -0.0285 0.0375)
+(0.0060 -0.0285 0.0375)
+(-0.0060 -0.0255 0.0375)
+(-0.0030 -0.0255 0.0375)
+(0.0000 -0.0255 0.0375)
+(0.0030 -0.0255 0.0375)
+(0.0060 -0.0255 0.0375)
+(-0.0060 -0.0225 0.0375)
+(-0.0030 -0.0225 0.0375)
+(0.0000 -0.0225 0.0375)
+(0.0030 -0.0225 0.0375)
+(0.0060 -0.0225 0.0375)
+(-0.0060 -0.0195 0.0375)
+(-0.0030 -0.0195 0.0375)
+(0.0000 -0.0195 0.0375)
+(0.0030 -0.0195 0.0375)
+(0.0060 -0.0195 0.0375)
+(-0.0060 -0.0165 0.0375)
+(-0.0030 -0.0165 0.0375)
+(0.0000 -0.0165 0.0375)
+(0.0030 -0.0165 0.0375)
+(0.0060 -0.0165 0.0375)
+(-0.0060 -0.0135 0.0375)
+(-0.0030 -0.0135 0.0375)
+(0.0000 -0.0135 0.0375)
+(0.0030 -0.0135 0.0375)
+(0.0060 -0.0135 0.0375)
+(-0.0060 -0.0105 0.0375)
+(-0.0030 -0.0105 0.0375)
+(0.0000 -0.0105 0.0375)
+(0.0030 -0.0105 0.0375)
+(0.0060 -0.0105 0.0375)
+(-0.0060 -0.0075 0.0375)
+(-0.0030 -0.0075 0.0375)
+(0.0000 -0.0075 0.0375)
+(0.0030 -0.0075 0.0375)
+(0.0060 -0.0075 0.0375)
+(-0.0060 -0.0045 0.0375)
+(-0.0030 -0.0045 0.0375)
+(0.0000 -0.0045 0.0375)
+(0.0030 -0.0045 0.0375)
+(0.0060 -0.0045 0.0375)
+(-0.0060 -0.0015 0.0375)
+(-0.0030 -0.0015 0.0375)
+(0.0000 -0.0015 0.0375)
+(0.0030 -0.0015 0.0375)
+(0.0060 -0.0015 0.0375)
+(-0.0060 0.0015 0.0375)
+(-0.0030 0.0015 0.0375)
+(0.0000 0.0015 0.0375)
+(0.0030 0.0015 0.0375)
+(0.0060 0.0015 0.0375)
+(-0.0060 0.0045 0.0375)
+(-0.0030 0.0045 0.0375)
+(0.0000 0.0045 0.0375)
+(0.0030 0.0045 0.0375)
+(0.0060 0.0045 0.0375)
+(-0.0060 0.0075 0.0375)
+(-0.0030 0.0075 0.0375)
+(0.0000 0.0075 0.0375)
+(0.0030 0.0075 0.0375)
+(0.0060 0.0075 0.0375)
+(-0.0060 0.0105 0.0375)
+(-0.0030 0.0105 0.0375)
+(0.0000 0.0105 0.0375)
+(0.0030 0.0105 0.0375)
+(0.0060 0.0105 0.0375)
+(-0.0060 0.0135 0.0375)
+(-0.0030 0.0135 0.0375)
+(0.0000 0.0135 0.0375)
+(0.0030 0.0135 0.0375)
+(0.0060 0.0135 0.0375)
+(-0.0060 0.0165 0.0375)
+(-0.0030 0.0165 0.0375)
+(0.0000 0.0165 0.0375)
+(0.0030 0.0165 0.0375)
+(0.0060 0.0165 0.0375)
+(-0.0060 0.0195 0.0375)
+(-0.0030 0.0195 0.0375)
+(0.0000 0.0195 0.0375)
+(0.0030 0.0195 0.0375)
+(0.0060 0.0195 0.0375)
+(-0.0060 0.0225 0.0375)
+(-0.0030 0.0225 0.0375)
+(0.0000 0.0225 0.0375)
+(0.0030 0.0225 0.0375)
+(0.0060 0.0225 0.0375)
+(-0.0060 0.0255 0.0375)
+(-0.0030 0.0255 0.0375)
+(0.0000 0.0255 0.0375)
+(0.0030 0.0255 0.0375)
+(0.0060 0.0255 0.0375)
+(-0.0060 0.0285 0.0375)
+(-0.0030 0.0285 0.0375)
+(0.0000 0.0285 0.0375)
+(0.0030 0.0285 0.0375)
+(0.0060 0.0285 0.0375)
+(-0.0060 0.0315 0.0375)
+(-0.0030 0.0315 0.0375)
+(0.0000 0.0315 0.0375)
+(0.0030 0.0315 0.0375)
+(0.0060 0.0315 0.0375)
+(-0.0060 0.0345 0.0375)
+(-0.0030 0.0345 0.0375)
+(0.0000 0.0345 0.0375)
+(0.0030 0.0345 0.0375)
+(0.0060 0.0345 0.0375)
+(-0.0060 0.0375 0.0375)
+(-0.0030 0.0375 0.0375)
+(0.0000 0.0375 0.0375)
+(0.0030 0.0375 0.0375)
+(0.0060 0.0375 0.0375)
+(-0.0060 0.0405 0.0375)
+(-0.0030 0.0405 0.0375)
+(0.0000 0.0405 0.0375)
+(0.0030 0.0405 0.0375)
+(0.0060 0.0405 0.0375)
+(-0.0060 0.0435 0.0375)
+(-0.0030 0.0435 0.0375)
+(0.0000 0.0435 0.0375)
+(0.0030 0.0435 0.0375)
+(0.0060 0.0435 0.0375)
+(-0.0060 0.0465 0.0375)
+(-0.0030 0.0465 0.0375)
+(0.0000 0.0465 0.0375)
+(0.0030 0.0465 0.0375)
+(0.0060 0.0465 0.0375)
+(-0.0060 0.0495 0.0375)
+(-0.0030 0.0495 0.0375)
+(0.0000 0.0495 0.0375)
+(0.0030 0.0495 0.0375)
+(0.0060 0.0495 0.0375)
+(-0.0060 0.0525 0.0375)
+(-0.0030 0.0525 0.0375)
+(0.0000 0.0525 0.0375)
+(0.0030 0.0525 0.0375)
+(0.0060 0.0525 0.0375)
+(-0.0060 0.0555 0.0375)
+(-0.0030 0.0555 0.0375)
+(0.0000 0.0555 0.0375)
+(0.0030 0.0555 0.0375)
+(0.0060 0.0555 0.0375)
+(-0.0060 0.0585 0.0375)
+(-0.0030 0.0585 0.0375)
+(0.0000 0.0585 0.0375)
+(0.0030 0.0585 0.0375)
+(0.0060 0.0585 0.0375)
+(-0.0060 0.0615 0.0375)
+(-0.0030 0.0615 0.0375)
+(0.0000 0.0615 0.0375)
+(0.0030 0.0615 0.0375)
+(0.0060 0.0615 0.0375)
+(-0.0060 0.0645 0.0375)
+(-0.0030 0.0645 0.0375)
+(0.0000 0.0645 0.0375)
+(0.0030 0.0645 0.0375)
+(0.0060 0.0645 0.0375)
+(-0.0060 0.0675 0.0375)
+(-0.0030 0.0675 0.0375)
+(0.0000 0.0675 0.0375)
+(0.0030 0.0675 0.0375)
+(0.0060 0.0675 0.0375)
+(-0.0060 0.0705 0.0375)
+(-0.0030 0.0705 0.0375)
+(0.0000 0.0705 0.0375)
+(0.0030 0.0705 0.0375)
+(0.0060 0.0705 0.0375)
+(-0.0060 0.0735 0.0375)
+(-0.0030 0.0735 0.0375)
+(0.0000 0.0735 0.0375)
+(0.0030 0.0735 0.0375)
+(0.0060 0.0735 0.0375)
+(-0.0060 -0.0735 0.0405)
+(-0.0030 -0.0735 0.0405)
+(0.0000 -0.0735 0.0405)
+(0.0030 -0.0735 0.0405)
+(0.0060 -0.0735 0.0405)
+(-0.0060 -0.0705 0.0405)
+(-0.0030 -0.0705 0.0405)
+(0.0000 -0.0705 0.0405)
+(0.0030 -0.0705 0.0405)
+(0.0060 -0.0705 0.0405)
+(-0.0060 -0.0675 0.0405)
+(-0.0030 -0.0675 0.0405)
+(0.0000 -0.0675 0.0405)
+(0.0030 -0.0675 0.0405)
+(0.0060 -0.0675 0.0405)
+(-0.0060 -0.0645 0.0405)
+(-0.0030 -0.0645 0.0405)
+(0.0000 -0.0645 0.0405)
+(0.0030 -0.0645 0.0405)
+(0.0060 -0.0645 0.0405)
+(-0.0060 -0.0615 0.0405)
+(-0.0030 -0.0615 0.0405)
+(0.0000 -0.0615 0.0405)
+(0.0030 -0.0615 0.0405)
+(0.0060 -0.0615 0.0405)
+(-0.0060 -0.0585 0.0405)
+(-0.0030 -0.0585 0.0405)
+(0.0000 -0.0585 0.0405)
+(0.0030 -0.0585 0.0405)
+(0.0060 -0.0585 0.0405)
+(-0.0060 -0.0555 0.0405)
+(-0.0030 -0.0555 0.0405)
+(0.0000 -0.0555 0.0405)
+(0.0030 -0.0555 0.0405)
+(0.0060 -0.0555 0.0405)
+(-0.0060 -0.0525 0.0405)
+(-0.0030 -0.0525 0.0405)
+(0.0000 -0.0525 0.0405)
+(0.0030 -0.0525 0.0405)
+(0.0060 -0.0525 0.0405)
+(-0.0060 -0.0495 0.0405)
+(-0.0030 -0.0495 0.0405)
+(0.0000 -0.0495 0.0405)
+(0.0030 -0.0495 0.0405)
+(0.0060 -0.0495 0.0405)
+(-0.0060 -0.0465 0.0405)
+(-0.0030 -0.0465 0.0405)
+(0.0000 -0.0465 0.0405)
+(0.0030 -0.0465 0.0405)
+(0.0060 -0.0465 0.0405)
+(-0.0060 -0.0435 0.0405)
+(-0.0030 -0.0435 0.0405)
+(0.0000 -0.0435 0.0405)
+(0.0030 -0.0435 0.0405)
+(0.0060 -0.0435 0.0405)
+(-0.0060 -0.0405 0.0405)
+(-0.0030 -0.0405 0.0405)
+(0.0000 -0.0405 0.0405)
+(0.0030 -0.0405 0.0405)
+(0.0060 -0.0405 0.0405)
+(-0.0060 -0.0375 0.0405)
+(-0.0030 -0.0375 0.0405)
+(0.0000 -0.0375 0.0405)
+(0.0030 -0.0375 0.0405)
+(0.0060 -0.0375 0.0405)
+(-0.0060 -0.0345 0.0405)
+(-0.0030 -0.0345 0.0405)
+(0.0000 -0.0345 0.0405)
+(0.0030 -0.0345 0.0405)
+(0.0060 -0.0345 0.0405)
+(-0.0060 -0.0315 0.0405)
+(-0.0030 -0.0315 0.0405)
+(0.0000 -0.0315 0.0405)
+(0.0030 -0.0315 0.0405)
+(0.0060 -0.0315 0.0405)
+(-0.0060 -0.0285 0.0405)
+(-0.0030 -0.0285 0.0405)
+(0.0000 -0.0285 0.0405)
+(0.0030 -0.0285 0.0405)
+(0.0060 -0.0285 0.0405)
+(-0.0060 -0.0255 0.0405)
+(-0.0030 -0.0255 0.0405)
+(0.0000 -0.0255 0.0405)
+(0.0030 -0.0255 0.0405)
+(0.0060 -0.0255 0.0405)
+(-0.0060 -0.0225 0.0405)
+(-0.0030 -0.0225 0.0405)
+(0.0000 -0.0225 0.0405)
+(0.0030 -0.0225 0.0405)
+(0.0060 -0.0225 0.0405)
+(-0.0060 -0.0195 0.0405)
+(-0.0030 -0.0195 0.0405)
+(0.0000 -0.0195 0.0405)
+(0.0030 -0.0195 0.0405)
+(0.0060 -0.0195 0.0405)
+(-0.0060 -0.0165 0.0405)
+(-0.0030 -0.0165 0.0405)
+(0.0000 -0.0165 0.0405)
+(0.0030 -0.0165 0.0405)
+(0.0060 -0.0165 0.0405)
+(-0.0060 -0.0135 0.0405)
+(-0.0030 -0.0135 0.0405)
+(0.0000 -0.0135 0.0405)
+(0.0030 -0.0135 0.0405)
+(0.0060 -0.0135 0.0405)
+(-0.0060 -0.0105 0.0405)
+(-0.0030 -0.0105 0.0405)
+(0.0000 -0.0105 0.0405)
+(0.0030 -0.0105 0.0405)
+(0.0060 -0.0105 0.0405)
+(-0.0060 -0.0075 0.0405)
+(-0.0030 -0.0075 0.0405)
+(0.0000 -0.0075 0.0405)
+(0.0030 -0.0075 0.0405)
+(0.0060 -0.0075 0.0405)
+(-0.0060 -0.0045 0.0405)
+(-0.0030 -0.0045 0.0405)
+(0.0000 -0.0045 0.0405)
+(0.0030 -0.0045 0.0405)
+(0.0060 -0.0045 0.0405)
+(-0.0060 -0.0015 0.0405)
+(-0.0030 -0.0015 0.0405)
+(0.0000 -0.0015 0.0405)
+(0.0030 -0.0015 0.0405)
+(0.0060 -0.0015 0.0405)
+(-0.0060 0.0015 0.0405)
+(-0.0030 0.0015 0.0405)
+(0.0000 0.0015 0.0405)
+(0.0030 0.0015 0.0405)
+(0.0060 0.0015 0.0405)
+(-0.0060 0.0045 0.0405)
+(-0.0030 0.0045 0.0405)
+(0.0000 0.0045 0.0405)
+(0.0030 0.0045 0.0405)
+(0.0060 0.0045 0.0405)
+(-0.0060 0.0075 0.0405)
+(-0.0030 0.0075 0.0405)
+(0.0000 0.0075 0.0405)
+(0.0030 0.0075 0.0405)
+(0.0060 0.0075 0.0405)
+(-0.0060 0.0105 0.0405)
+(-0.0030 0.0105 0.0405)
+(0.0000 0.0105 0.0405)
+(0.0030 0.0105 0.0405)
+(0.0060 0.0105 0.0405)
+(-0.0060 0.0135 0.0405)
+(-0.0030 0.0135 0.0405)
+(0.0000 0.0135 0.0405)
+(0.0030 0.0135 0.0405)
+(0.0060 0.0135 0.0405)
+(-0.0060 0.0165 0.0405)
+(-0.0030 0.0165 0.0405)
+(0.0000 0.0165 0.0405)
+(0.0030 0.0165 0.0405)
+(0.0060 0.0165 0.0405)
+(-0.0060 0.0195 0.0405)
+(-0.0030 0.0195 0.0405)
+(0.0000 0.0195 0.0405)
+(0.0030 0.0195 0.0405)
+(0.0060 0.0195 0.0405)
+(-0.0060 0.0225 0.0405)
+(-0.0030 0.0225 0.0405)
+(0.0000 0.0225 0.0405)
+(0.0030 0.0225 0.0405)
+(0.0060 0.0225 0.0405)
+(-0.0060 0.0255 0.0405)
+(-0.0030 0.0255 0.0405)
+(0.0000 0.0255 0.0405)
+(0.0030 0.0255 0.0405)
+(0.0060 0.0255 0.0405)
+(-0.0060 0.0285 0.0405)
+(-0.0030 0.0285 0.0405)
+(0.0000 0.0285 0.0405)
+(0.0030 0.0285 0.0405)
+(0.0060 0.0285 0.0405)
+(-0.0060 0.0315 0.0405)
+(-0.0030 0.0315 0.0405)
+(0.0000 0.0315 0.0405)
+(0.0030 0.0315 0.0405)
+(0.0060 0.0315 0.0405)
+(-0.0060 0.0345 0.0405)
+(-0.0030 0.0345 0.0405)
+(0.0000 0.0345 0.0405)
+(0.0030 0.0345 0.0405)
+(0.0060 0.0345 0.0405)
+(-0.0060 0.0375 0.0405)
+(-0.0030 0.0375 0.0405)
+(0.0000 0.0375 0.0405)
+(0.0030 0.0375 0.0405)
+(0.0060 0.0375 0.0405)
+(-0.0060 0.0405 0.0405)
+(-0.0030 0.0405 0.0405)
+(0.0000 0.0405 0.0405)
+(0.0030 0.0405 0.0405)
+(0.0060 0.0405 0.0405)
+(-0.0060 0.0435 0.0405)
+(-0.0030 0.0435 0.0405)
+(0.0000 0.0435 0.0405)
+(0.0030 0.0435 0.0405)
+(0.0060 0.0435 0.0405)
+(-0.0060 0.0465 0.0405)
+(-0.0030 0.0465 0.0405)
+(0.0000 0.0465 0.0405)
+(0.0030 0.0465 0.0405)
+(0.0060 0.0465 0.0405)
+(-0.0060 0.0495 0.0405)
+(-0.0030 0.0495 0.0405)
+(0.0000 0.0495 0.0405)
+(0.0030 0.0495 0.0405)
+(0.0060 0.0495 0.0405)
+(-0.0060 0.0525 0.0405)
+(-0.0030 0.0525 0.0405)
+(0.0000 0.0525 0.0405)
+(0.0030 0.0525 0.0405)
+(0.0060 0.0525 0.0405)
+(-0.0060 0.0555 0.0405)
+(-0.0030 0.0555 0.0405)
+(0.0000 0.0555 0.0405)
+(0.0030 0.0555 0.0405)
+(0.0060 0.0555 0.0405)
+(-0.0060 0.0585 0.0405)
+(-0.0030 0.0585 0.0405)
+(0.0000 0.0585 0.0405)
+(0.0030 0.0585 0.0405)
+(0.0060 0.0585 0.0405)
+(-0.0060 0.0615 0.0405)
+(-0.0030 0.0615 0.0405)
+(0.0000 0.0615 0.0405)
+(0.0030 0.0615 0.0405)
+(0.0060 0.0615 0.0405)
+(-0.0060 0.0645 0.0405)
+(-0.0030 0.0645 0.0405)
+(0.0000 0.0645 0.0405)
+(0.0030 0.0645 0.0405)
+(0.0060 0.0645 0.0405)
+(-0.0060 0.0675 0.0405)
+(-0.0030 0.0675 0.0405)
+(0.0000 0.0675 0.0405)
+(0.0030 0.0675 0.0405)
+(0.0060 0.0675 0.0405)
+(-0.0060 0.0705 0.0405)
+(-0.0030 0.0705 0.0405)
+(0.0000 0.0705 0.0405)
+(0.0030 0.0705 0.0405)
+(0.0060 0.0705 0.0405)
+(-0.0060 0.0735 0.0405)
+(-0.0030 0.0735 0.0405)
+(0.0000 0.0735 0.0405)
+(0.0030 0.0735 0.0405)
+(0.0060 0.0735 0.0405)
+(-0.0060 -0.0735 0.0435)
+(-0.0030 -0.0735 0.0435)
+(0.0000 -0.0735 0.0435)
+(0.0030 -0.0735 0.0435)
+(0.0060 -0.0735 0.0435)
+(-0.0060 -0.0705 0.0435)
+(-0.0030 -0.0705 0.0435)
+(0.0000 -0.0705 0.0435)
+(0.0030 -0.0705 0.0435)
+(0.0060 -0.0705 0.0435)
+(-0.0060 -0.0675 0.0435)
+(-0.0030 -0.0675 0.0435)
+(0.0000 -0.0675 0.0435)
+(0.0030 -0.0675 0.0435)
+(0.0060 -0.0675 0.0435)
+(-0.0060 -0.0645 0.0435)
+(-0.0030 -0.0645 0.0435)
+(0.0000 -0.0645 0.0435)
+(0.0030 -0.0645 0.0435)
+(0.0060 -0.0645 0.0435)
+(-0.0060 -0.0615 0.0435)
+(-0.0030 -0.0615 0.0435)
+(0.0000 -0.0615 0.0435)
+(0.0030 -0.0615 0.0435)
+(0.0060 -0.0615 0.0435)
+(-0.0060 -0.0585 0.0435)
+(-0.0030 -0.0585 0.0435)
+(0.0000 -0.0585 0.0435)
+(0.0030 -0.0585 0.0435)
+(0.0060 -0.0585 0.0435)
+(-0.0060 -0.0555 0.0435)
+(-0.0030 -0.0555 0.0435)
+(0.0000 -0.0555 0.0435)
+(0.0030 -0.0555 0.0435)
+(0.0060 -0.0555 0.0435)
+(-0.0060 -0.0525 0.0435)
+(-0.0030 -0.0525 0.0435)
+(0.0000 -0.0525 0.0435)
+(0.0030 -0.0525 0.0435)
+(0.0060 -0.0525 0.0435)
+(-0.0060 -0.0495 0.0435)
+(-0.0030 -0.0495 0.0435)
+(0.0000 -0.0495 0.0435)
+(0.0030 -0.0495 0.0435)
+(0.0060 -0.0495 0.0435)
+(-0.0060 -0.0465 0.0435)
+(-0.0030 -0.0465 0.0435)
+(0.0000 -0.0465 0.0435)
+(0.0030 -0.0465 0.0435)
+(0.0060 -0.0465 0.0435)
+(-0.0060 -0.0435 0.0435)
+(-0.0030 -0.0435 0.0435)
+(0.0000 -0.0435 0.0435)
+(0.0030 -0.0435 0.0435)
+(0.0060 -0.0435 0.0435)
+(-0.0060 -0.0405 0.0435)
+(-0.0030 -0.0405 0.0435)
+(0.0000 -0.0405 0.0435)
+(0.0030 -0.0405 0.0435)
+(0.0060 -0.0405 0.0435)
+(-0.0060 -0.0375 0.0435)
+(-0.0030 -0.0375 0.0435)
+(0.0000 -0.0375 0.0435)
+(0.0030 -0.0375 0.0435)
+(0.0060 -0.0375 0.0435)
+(-0.0060 -0.0345 0.0435)
+(-0.0030 -0.0345 0.0435)
+(0.0000 -0.0345 0.0435)
+(0.0030 -0.0345 0.0435)
+(0.0060 -0.0345 0.0435)
+(-0.0060 -0.0315 0.0435)
+(-0.0030 -0.0315 0.0435)
+(0.0000 -0.0315 0.0435)
+(0.0030 -0.0315 0.0435)
+(0.0060 -0.0315 0.0435)
+(-0.0060 -0.0285 0.0435)
+(-0.0030 -0.0285 0.0435)
+(0.0000 -0.0285 0.0435)
+(0.0030 -0.0285 0.0435)
+(0.0060 -0.0285 0.0435)
+(-0.0060 -0.0255 0.0435)
+(-0.0030 -0.0255 0.0435)
+(0.0000 -0.0255 0.0435)
+(0.0030 -0.0255 0.0435)
+(0.0060 -0.0255 0.0435)
+(-0.0060 -0.0225 0.0435)
+(-0.0030 -0.0225 0.0435)
+(0.0000 -0.0225 0.0435)
+(0.0030 -0.0225 0.0435)
+(0.0060 -0.0225 0.0435)
+(-0.0060 -0.0195 0.0435)
+(-0.0030 -0.0195 0.0435)
+(0.0000 -0.0195 0.0435)
+(0.0030 -0.0195 0.0435)
+(0.0060 -0.0195 0.0435)
+(-0.0060 -0.0165 0.0435)
+(-0.0030 -0.0165 0.0435)
+(0.0000 -0.0165 0.0435)
+(0.0030 -0.0165 0.0435)
+(0.0060 -0.0165 0.0435)
+(-0.0060 -0.0135 0.0435)
+(-0.0030 -0.0135 0.0435)
+(0.0000 -0.0135 0.0435)
+(0.0030 -0.0135 0.0435)
+(0.0060 -0.0135 0.0435)
+(-0.0060 -0.0105 0.0435)
+(-0.0030 -0.0105 0.0435)
+(0.0000 -0.0105 0.0435)
+(0.0030 -0.0105 0.0435)
+(0.0060 -0.0105 0.0435)
+(-0.0060 -0.0075 0.0435)
+(-0.0030 -0.0075 0.0435)
+(0.0000 -0.0075 0.0435)
+(0.0030 -0.0075 0.0435)
+(0.0060 -0.0075 0.0435)
+(-0.0060 -0.0045 0.0435)
+(-0.0030 -0.0045 0.0435)
+(0.0000 -0.0045 0.0435)
+(0.0030 -0.0045 0.0435)
+(0.0060 -0.0045 0.0435)
+(-0.0060 -0.0015 0.0435)
+(-0.0030 -0.0015 0.0435)
+(0.0000 -0.0015 0.0435)
+(0.0030 -0.0015 0.0435)
+(0.0060 -0.0015 0.0435)
+(-0.0060 0.0015 0.0435)
+(-0.0030 0.0015 0.0435)
+(0.0000 0.0015 0.0435)
+(0.0030 0.0015 0.0435)
+(0.0060 0.0015 0.0435)
+(-0.0060 0.0045 0.0435)
+(-0.0030 0.0045 0.0435)
+(0.0000 0.0045 0.0435)
+(0.0030 0.0045 0.0435)
+(0.0060 0.0045 0.0435)
+(-0.0060 0.0075 0.0435)
+(-0.0030 0.0075 0.0435)
+(0.0000 0.0075 0.0435)
+(0.0030 0.0075 0.0435)
+(0.0060 0.0075 0.0435)
+(-0.0060 0.0105 0.0435)
+(-0.0030 0.0105 0.0435)
+(0.0000 0.0105 0.0435)
+(0.0030 0.0105 0.0435)
+(0.0060 0.0105 0.0435)
+(-0.0060 0.0135 0.0435)
+(-0.0030 0.0135 0.0435)
+(0.0000 0.0135 0.0435)
+(0.0030 0.0135 0.0435)
+(0.0060 0.0135 0.0435)
+(-0.0060 0.0165 0.0435)
+(-0.0030 0.0165 0.0435)
+(0.0000 0.0165 0.0435)
+(0.0030 0.0165 0.0435)
+(0.0060 0.0165 0.0435)
+(-0.0060 0.0195 0.0435)
+(-0.0030 0.0195 0.0435)
+(0.0000 0.0195 0.0435)
+(0.0030 0.0195 0.0435)
+(0.0060 0.0195 0.0435)
+(-0.0060 0.0225 0.0435)
+(-0.0030 0.0225 0.0435)
+(0.0000 0.0225 0.0435)
+(0.0030 0.0225 0.0435)
+(0.0060 0.0225 0.0435)
+(-0.0060 0.0255 0.0435)
+(-0.0030 0.0255 0.0435)
+(0.0000 0.0255 0.0435)
+(0.0030 0.0255 0.0435)
+(0.0060 0.0255 0.0435)
+(-0.0060 0.0285 0.0435)
+(-0.0030 0.0285 0.0435)
+(0.0000 0.0285 0.0435)
+(0.0030 0.0285 0.0435)
+(0.0060 0.0285 0.0435)
+(-0.0060 0.0315 0.0435)
+(-0.0030 0.0315 0.0435)
+(0.0000 0.0315 0.0435)
+(0.0030 0.0315 0.0435)
+(0.0060 0.0315 0.0435)
+(-0.0060 0.0345 0.0435)
+(-0.0030 0.0345 0.0435)
+(0.0000 0.0345 0.0435)
+(0.0030 0.0345 0.0435)
+(0.0060 0.0345 0.0435)
+(-0.0060 0.0375 0.0435)
+(-0.0030 0.0375 0.0435)
+(0.0000 0.0375 0.0435)
+(0.0030 0.0375 0.0435)
+(0.0060 0.0375 0.0435)
+(-0.0060 0.0405 0.0435)
+(-0.0030 0.0405 0.0435)
+(0.0000 0.0405 0.0435)
+(0.0030 0.0405 0.0435)
+(0.0060 0.0405 0.0435)
+(-0.0060 0.0435 0.0435)
+(-0.0030 0.0435 0.0435)
+(0.0000 0.0435 0.0435)
+(0.0030 0.0435 0.0435)
+(0.0060 0.0435 0.0435)
+(-0.0060 0.0465 0.0435)
+(-0.0030 0.0465 0.0435)
+(0.0000 0.0465 0.0435)
+(0.0030 0.0465 0.0435)
+(0.0060 0.0465 0.0435)
+(-0.0060 0.0495 0.0435)
+(-0.0030 0.0495 0.0435)
+(0.0000 0.0495 0.0435)
+(0.0030 0.0495 0.0435)
+(0.0060 0.0495 0.0435)
+(-0.0060 0.0525 0.0435)
+(-0.0030 0.0525 0.0435)
+(0.0000 0.0525 0.0435)
+(0.0030 0.0525 0.0435)
+(0.0060 0.0525 0.0435)
+(-0.0060 0.0555 0.0435)
+(-0.0030 0.0555 0.0435)
+(0.0000 0.0555 0.0435)
+(0.0030 0.0555 0.0435)
+(0.0060 0.0555 0.0435)
+(-0.0060 0.0585 0.0435)
+(-0.0030 0.0585 0.0435)
+(0.0000 0.0585 0.0435)
+(0.0030 0.0585 0.0435)
+(0.0060 0.0585 0.0435)
+(-0.0060 0.0615 0.0435)
+(-0.0030 0.0615 0.0435)
+(0.0000 0.0615 0.0435)
+(0.0030 0.0615 0.0435)
+(0.0060 0.0615 0.0435)
+(-0.0060 0.0645 0.0435)
+(-0.0030 0.0645 0.0435)
+(0.0000 0.0645 0.0435)
+(0.0030 0.0645 0.0435)
+(0.0060 0.0645 0.0435)
+(-0.0060 0.0675 0.0435)
+(-0.0030 0.0675 0.0435)
+(0.0000 0.0675 0.0435)
+(0.0030 0.0675 0.0435)
+(0.0060 0.0675 0.0435)
+(-0.0060 0.0705 0.0435)
+(-0.0030 0.0705 0.0435)
+(0.0000 0.0705 0.0435)
+(0.0030 0.0705 0.0435)
+(0.0060 0.0705 0.0435)
+(-0.0060 0.0735 0.0435)
+(-0.0030 0.0735 0.0435)
+(0.0000 0.0735 0.0435)
+(0.0030 0.0735 0.0435)
+(0.0060 0.0735 0.0435)
+(-0.0060 -0.0735 0.0465)
+(-0.0030 -0.0735 0.0465)
+(0.0000 -0.0735 0.0465)
+(0.0030 -0.0735 0.0465)
+(0.0060 -0.0735 0.0465)
+(-0.0060 -0.0705 0.0465)
+(-0.0030 -0.0705 0.0465)
+(0.0000 -0.0705 0.0465)
+(0.0030 -0.0705 0.0465)
+(0.0060 -0.0705 0.0465)
+(-0.0060 -0.0675 0.0465)
+(-0.0030 -0.0675 0.0465)
+(0.0000 -0.0675 0.0465)
+(0.0030 -0.0675 0.0465)
+(0.0060 -0.0675 0.0465)
+(-0.0060 -0.0645 0.0465)
+(-0.0030 -0.0645 0.0465)
+(0.0000 -0.0645 0.0465)
+(0.0030 -0.0645 0.0465)
+(0.0060 -0.0645 0.0465)
+(-0.0060 -0.0615 0.0465)
+(-0.0030 -0.0615 0.0465)
+(0.0000 -0.0615 0.0465)
+(0.0030 -0.0615 0.0465)
+(0.0060 -0.0615 0.0465)
+(-0.0060 -0.0585 0.0465)
+(-0.0030 -0.0585 0.0465)
+(0.0000 -0.0585 0.0465)
+(0.0030 -0.0585 0.0465)
+(0.0060 -0.0585 0.0465)
+(-0.0060 -0.0555 0.0465)
+(-0.0030 -0.0555 0.0465)
+(0.0000 -0.0555 0.0465)
+(0.0030 -0.0555 0.0465)
+(0.0060 -0.0555 0.0465)
+(-0.0060 -0.0525 0.0465)
+(-0.0030 -0.0525 0.0465)
+(0.0000 -0.0525 0.0465)
+(0.0030 -0.0525 0.0465)
+(0.0060 -0.0525 0.0465)
+(-0.0060 -0.0495 0.0465)
+(-0.0030 -0.0495 0.0465)
+(0.0000 -0.0495 0.0465)
+(0.0030 -0.0495 0.0465)
+(0.0060 -0.0495 0.0465)
+(-0.0060 -0.0465 0.0465)
+(-0.0030 -0.0465 0.0465)
+(0.0000 -0.0465 0.0465)
+(0.0030 -0.0465 0.0465)
+(0.0060 -0.0465 0.0465)
+(-0.0060 -0.0435 0.0465)
+(-0.0030 -0.0435 0.0465)
+(0.0000 -0.0435 0.0465)
+(0.0030 -0.0435 0.0465)
+(0.0060 -0.0435 0.0465)
+(-0.0060 -0.0405 0.0465)
+(-0.0030 -0.0405 0.0465)
+(0.0000 -0.0405 0.0465)
+(0.0030 -0.0405 0.0465)
+(0.0060 -0.0405 0.0465)
+(-0.0060 -0.0375 0.0465)
+(-0.0030 -0.0375 0.0465)
+(0.0000 -0.0375 0.0465)
+(0.0030 -0.0375 0.0465)
+(0.0060 -0.0375 0.0465)
+(-0.0060 -0.0345 0.0465)
+(-0.0030 -0.0345 0.0465)
+(0.0000 -0.0345 0.0465)
+(0.0030 -0.0345 0.0465)
+(0.0060 -0.0345 0.0465)
+(-0.0060 -0.0315 0.0465)
+(-0.0030 -0.0315 0.0465)
+(0.0000 -0.0315 0.0465)
+(0.0030 -0.0315 0.0465)
+(0.0060 -0.0315 0.0465)
+(-0.0060 -0.0285 0.0465)
+(-0.0030 -0.0285 0.0465)
+(0.0000 -0.0285 0.0465)
+(0.0030 -0.0285 0.0465)
+(0.0060 -0.0285 0.0465)
+(-0.0060 -0.0255 0.0465)
+(-0.0030 -0.0255 0.0465)
+(0.0000 -0.0255 0.0465)
+(0.0030 -0.0255 0.0465)
+(0.0060 -0.0255 0.0465)
+(-0.0060 -0.0225 0.0465)
+(-0.0030 -0.0225 0.0465)
+(0.0000 -0.0225 0.0465)
+(0.0030 -0.0225 0.0465)
+(0.0060 -0.0225 0.0465)
+(-0.0060 -0.0195 0.0465)
+(-0.0030 -0.0195 0.0465)
+(0.0000 -0.0195 0.0465)
+(0.0030 -0.0195 0.0465)
+(0.0060 -0.0195 0.0465)
+(-0.0060 -0.0165 0.0465)
+(-0.0030 -0.0165 0.0465)
+(0.0000 -0.0165 0.0465)
+(0.0030 -0.0165 0.0465)
+(0.0060 -0.0165 0.0465)
+(-0.0060 -0.0135 0.0465)
+(-0.0030 -0.0135 0.0465)
+(0.0000 -0.0135 0.0465)
+(0.0030 -0.0135 0.0465)
+(0.0060 -0.0135 0.0465)
+(-0.0060 -0.0105 0.0465)
+(-0.0030 -0.0105 0.0465)
+(0.0000 -0.0105 0.0465)
+(0.0030 -0.0105 0.0465)
+(0.0060 -0.0105 0.0465)
+(-0.0060 -0.0075 0.0465)
+(-0.0030 -0.0075 0.0465)
+(0.0000 -0.0075 0.0465)
+(0.0030 -0.0075 0.0465)
+(0.0060 -0.0075 0.0465)
+(-0.0060 -0.0045 0.0465)
+(-0.0030 -0.0045 0.0465)
+(0.0000 -0.0045 0.0465)
+(0.0030 -0.0045 0.0465)
+(0.0060 -0.0045 0.0465)
+(-0.0060 -0.0015 0.0465)
+(-0.0030 -0.0015 0.0465)
+(0.0000 -0.0015 0.0465)
+(0.0030 -0.0015 0.0465)
+(0.0060 -0.0015 0.0465)
+(-0.0060 0.0015 0.0465)
+(-0.0030 0.0015 0.0465)
+(0.0000 0.0015 0.0465)
+(0.0030 0.0015 0.0465)
+(0.0060 0.0015 0.0465)
+(-0.0060 0.0045 0.0465)
+(-0.0030 0.0045 0.0465)
+(0.0000 0.0045 0.0465)
+(0.0030 0.0045 0.0465)
+(0.0060 0.0045 0.0465)
+(-0.0060 0.0075 0.0465)
+(-0.0030 0.0075 0.0465)
+(0.0000 0.0075 0.0465)
+(0.0030 0.0075 0.0465)
+(0.0060 0.0075 0.0465)
+(-0.0060 0.0105 0.0465)
+(-0.0030 0.0105 0.0465)
+(0.0000 0.0105 0.0465)
+(0.0030 0.0105 0.0465)
+(0.0060 0.0105 0.0465)
+(-0.0060 0.0135 0.0465)
+(-0.0030 0.0135 0.0465)
+(0.0000 0.0135 0.0465)
+(0.0030 0.0135 0.0465)
+(0.0060 0.0135 0.0465)
+(-0.0060 0.0165 0.0465)
+(-0.0030 0.0165 0.0465)
+(0.0000 0.0165 0.0465)
+(0.0030 0.0165 0.0465)
+(0.0060 0.0165 0.0465)
+(-0.0060 0.0195 0.0465)
+(-0.0030 0.0195 0.0465)
+(0.0000 0.0195 0.0465)
+(0.0030 0.0195 0.0465)
+(0.0060 0.0195 0.0465)
+(-0.0060 0.0225 0.0465)
+(-0.0030 0.0225 0.0465)
+(0.0000 0.0225 0.0465)
+(0.0030 0.0225 0.0465)
+(0.0060 0.0225 0.0465)
+(-0.0060 0.0255 0.0465)
+(-0.0030 0.0255 0.0465)
+(0.0000 0.0255 0.0465)
+(0.0030 0.0255 0.0465)
+(0.0060 0.0255 0.0465)
+(-0.0060 0.0285 0.0465)
+(-0.0030 0.0285 0.0465)
+(0.0000 0.0285 0.0465)
+(0.0030 0.0285 0.0465)
+(0.0060 0.0285 0.0465)
+(-0.0060 0.0315 0.0465)
+(-0.0030 0.0315 0.0465)
+(0.0000 0.0315 0.0465)
+(0.0030 0.0315 0.0465)
+(0.0060 0.0315 0.0465)
+(-0.0060 0.0345 0.0465)
+(-0.0030 0.0345 0.0465)
+(0.0000 0.0345 0.0465)
+(0.0030 0.0345 0.0465)
+(0.0060 0.0345 0.0465)
+(-0.0060 0.0375 0.0465)
+(-0.0030 0.0375 0.0465)
+(0.0000 0.0375 0.0465)
+(0.0030 0.0375 0.0465)
+(0.0060 0.0375 0.0465)
+(-0.0060 0.0405 0.0465)
+(-0.0030 0.0405 0.0465)
+(0.0000 0.0405 0.0465)
+(0.0030 0.0405 0.0465)
+(0.0060 0.0405 0.0465)
+(-0.0060 0.0435 0.0465)
+(-0.0030 0.0435 0.0465)
+(0.0000 0.0435 0.0465)
+(0.0030 0.0435 0.0465)
+(0.0060 0.0435 0.0465)
+(-0.0060 0.0465 0.0465)
+(-0.0030 0.0465 0.0465)
+(0.0000 0.0465 0.0465)
+(0.0030 0.0465 0.0465)
+(0.0060 0.0465 0.0465)
+(-0.0060 0.0495 0.0465)
+(-0.0030 0.0495 0.0465)
+(0.0000 0.0495 0.0465)
+(0.0030 0.0495 0.0465)
+(0.0060 0.0495 0.0465)
+(-0.0060 0.0525 0.0465)
+(-0.0030 0.0525 0.0465)
+(0.0000 0.0525 0.0465)
+(0.0030 0.0525 0.0465)
+(0.0060 0.0525 0.0465)
+(-0.0060 0.0555 0.0465)
+(-0.0030 0.0555 0.0465)
+(0.0000 0.0555 0.0465)
+(0.0030 0.0555 0.0465)
+(0.0060 0.0555 0.0465)
+(-0.0060 0.0585 0.0465)
+(-0.0030 0.0585 0.0465)
+(0.0000 0.0585 0.0465)
+(0.0030 0.0585 0.0465)
+(0.0060 0.0585 0.0465)
+(-0.0060 0.0615 0.0465)
+(-0.0030 0.0615 0.0465)
+(0.0000 0.0615 0.0465)
+(0.0030 0.0615 0.0465)
+(0.0060 0.0615 0.0465)
+(-0.0060 0.0645 0.0465)
+(-0.0030 0.0645 0.0465)
+(0.0000 0.0645 0.0465)
+(0.0030 0.0645 0.0465)
+(0.0060 0.0645 0.0465)
+(-0.0060 0.0675 0.0465)
+(-0.0030 0.0675 0.0465)
+(0.0000 0.0675 0.0465)
+(0.0030 0.0675 0.0465)
+(0.0060 0.0675 0.0465)
+(-0.0060 0.0705 0.0465)
+(-0.0030 0.0705 0.0465)
+(0.0000 0.0705 0.0465)
+(0.0030 0.0705 0.0465)
+(0.0060 0.0705 0.0465)
+(-0.0060 0.0735 0.0465)
+(-0.0030 0.0735 0.0465)
+(0.0000 0.0735 0.0465)
+(0.0030 0.0735 0.0465)
+(0.0060 0.0735 0.0465)
+(-0.0060 -0.0735 0.0495)
+(-0.0030 -0.0735 0.0495)
+(0.0000 -0.0735 0.0495)
+(0.0030 -0.0735 0.0495)
+(0.0060 -0.0735 0.0495)
+(-0.0060 -0.0705 0.0495)
+(-0.0030 -0.0705 0.0495)
+(0.0000 -0.0705 0.0495)
+(0.0030 -0.0705 0.0495)
+(0.0060 -0.0705 0.0495)
+(-0.0060 -0.0675 0.0495)
+(-0.0030 -0.0675 0.0495)
+(0.0000 -0.0675 0.0495)
+(0.0030 -0.0675 0.0495)
+(0.0060 -0.0675 0.0495)
+(-0.0060 -0.0645 0.0495)
+(-0.0030 -0.0645 0.0495)
+(0.0000 -0.0645 0.0495)
+(0.0030 -0.0645 0.0495)
+(0.0060 -0.0645 0.0495)
+(-0.0060 -0.0615 0.0495)
+(-0.0030 -0.0615 0.0495)
+(0.0000 -0.0615 0.0495)
+(0.0030 -0.0615 0.0495)
+(0.0060 -0.0615 0.0495)
+(-0.0060 -0.0585 0.0495)
+(-0.0030 -0.0585 0.0495)
+(0.0000 -0.0585 0.0495)
+(0.0030 -0.0585 0.0495)
+(0.0060 -0.0585 0.0495)
+(-0.0060 -0.0555 0.0495)
+(-0.0030 -0.0555 0.0495)
+(0.0000 -0.0555 0.0495)
+(0.0030 -0.0555 0.0495)
+(0.0060 -0.0555 0.0495)
+(-0.0060 -0.0525 0.0495)
+(-0.0030 -0.0525 0.0495)
+(0.0000 -0.0525 0.0495)
+(0.0030 -0.0525 0.0495)
+(0.0060 -0.0525 0.0495)
+(-0.0060 -0.0495 0.0495)
+(-0.0030 -0.0495 0.0495)
+(0.0000 -0.0495 0.0495)
+(0.0030 -0.0495 0.0495)
+(0.0060 -0.0495 0.0495)
+(-0.0060 -0.0465 0.0495)
+(-0.0030 -0.0465 0.0495)
+(0.0000 -0.0465 0.0495)
+(0.0030 -0.0465 0.0495)
+(0.0060 -0.0465 0.0495)
+(-0.0060 -0.0435 0.0495)
+(-0.0030 -0.0435 0.0495)
+(0.0000 -0.0435 0.0495)
+(0.0030 -0.0435 0.0495)
+(0.0060 -0.0435 0.0495)
+(-0.0060 -0.0405 0.0495)
+(-0.0030 -0.0405 0.0495)
+(0.0000 -0.0405 0.0495)
+(0.0030 -0.0405 0.0495)
+(0.0060 -0.0405 0.0495)
+(-0.0060 -0.0375 0.0495)
+(-0.0030 -0.0375 0.0495)
+(0.0000 -0.0375 0.0495)
+(0.0030 -0.0375 0.0495)
+(0.0060 -0.0375 0.0495)
+(-0.0060 -0.0345 0.0495)
+(-0.0030 -0.0345 0.0495)
+(0.0000 -0.0345 0.0495)
+(0.0030 -0.0345 0.0495)
+(0.0060 -0.0345 0.0495)
+(-0.0060 -0.0315 0.0495)
+(-0.0030 -0.0315 0.0495)
+(0.0000 -0.0315 0.0495)
+(0.0030 -0.0315 0.0495)
+(0.0060 -0.0315 0.0495)
+(-0.0060 -0.0285 0.0495)
+(-0.0030 -0.0285 0.0495)
+(0.0000 -0.0285 0.0495)
+(0.0030 -0.0285 0.0495)
+(0.0060 -0.0285 0.0495)
+(-0.0060 -0.0255 0.0495)
+(-0.0030 -0.0255 0.0495)
+(0.0000 -0.0255 0.0495)
+(0.0030 -0.0255 0.0495)
+(0.0060 -0.0255 0.0495)
+(-0.0060 -0.0225 0.0495)
+(-0.0030 -0.0225 0.0495)
+(0.0000 -0.0225 0.0495)
+(0.0030 -0.0225 0.0495)
+(0.0060 -0.0225 0.0495)
+(-0.0060 -0.0195 0.0495)
+(-0.0030 -0.0195 0.0495)
+(0.0000 -0.0195 0.0495)
+(0.0030 -0.0195 0.0495)
+(0.0060 -0.0195 0.0495)
+(-0.0060 -0.0165 0.0495)
+(-0.0030 -0.0165 0.0495)
+(0.0000 -0.0165 0.0495)
+(0.0030 -0.0165 0.0495)
+(0.0060 -0.0165 0.0495)
+(-0.0060 -0.0135 0.0495)
+(-0.0030 -0.0135 0.0495)
+(0.0000 -0.0135 0.0495)
+(0.0030 -0.0135 0.0495)
+(0.0060 -0.0135 0.0495)
+(-0.0060 -0.0105 0.0495)
+(-0.0030 -0.0105 0.0495)
+(0.0000 -0.0105 0.0495)
+(0.0030 -0.0105 0.0495)
+(0.0060 -0.0105 0.0495)
+(-0.0060 -0.0075 0.0495)
+(-0.0030 -0.0075 0.0495)
+(0.0000 -0.0075 0.0495)
+(0.0030 -0.0075 0.0495)
+(0.0060 -0.0075 0.0495)
+(-0.0060 -0.0045 0.0495)
+(-0.0030 -0.0045 0.0495)
+(0.0000 -0.0045 0.0495)
+(0.0030 -0.0045 0.0495)
+(0.0060 -0.0045 0.0495)
+(-0.0060 -0.0015 0.0495)
+(-0.0030 -0.0015 0.0495)
+(0.0000 -0.0015 0.0495)
+(0.0030 -0.0015 0.0495)
+(0.0060 -0.0015 0.0495)
+(-0.0060 0.0015 0.0495)
+(-0.0030 0.0015 0.0495)
+(0.0000 0.0015 0.0495)
+(0.0030 0.0015 0.0495)
+(0.0060 0.0015 0.0495)
+(-0.0060 0.0045 0.0495)
+(-0.0030 0.0045 0.0495)
+(0.0000 0.0045 0.0495)
+(0.0030 0.0045 0.0495)
+(0.0060 0.0045 0.0495)
+(-0.0060 0.0075 0.0495)
+(-0.0030 0.0075 0.0495)
+(0.0000 0.0075 0.0495)
+(0.0030 0.0075 0.0495)
+(0.0060 0.0075 0.0495)
+(-0.0060 0.0105 0.0495)
+(-0.0030 0.0105 0.0495)
+(0.0000 0.0105 0.0495)
+(0.0030 0.0105 0.0495)
+(0.0060 0.0105 0.0495)
+(-0.0060 0.0135 0.0495)
+(-0.0030 0.0135 0.0495)
+(0.0000 0.0135 0.0495)
+(0.0030 0.0135 0.0495)
+(0.0060 0.0135 0.0495)
+(-0.0060 0.0165 0.0495)
+(-0.0030 0.0165 0.0495)
+(0.0000 0.0165 0.0495)
+(0.0030 0.0165 0.0495)
+(0.0060 0.0165 0.0495)
+(-0.0060 0.0195 0.0495)
+(-0.0030 0.0195 0.0495)
+(0.0000 0.0195 0.0495)
+(0.0030 0.0195 0.0495)
+(0.0060 0.0195 0.0495)
+(-0.0060 0.0225 0.0495)
+(-0.0030 0.0225 0.0495)
+(0.0000 0.0225 0.0495)
+(0.0030 0.0225 0.0495)
+(0.0060 0.0225 0.0495)
+(-0.0060 0.0255 0.0495)
+(-0.0030 0.0255 0.0495)
+(0.0000 0.0255 0.0495)
+(0.0030 0.0255 0.0495)
+(0.0060 0.0255 0.0495)
+(-0.0060 0.0285 0.0495)
+(-0.0030 0.0285 0.0495)
+(0.0000 0.0285 0.0495)
+(0.0030 0.0285 0.0495)
+(0.0060 0.0285 0.0495)
+(-0.0060 0.0315 0.0495)
+(-0.0030 0.0315 0.0495)
+(0.0000 0.0315 0.0495)
+(0.0030 0.0315 0.0495)
+(0.0060 0.0315 0.0495)
+(-0.0060 0.0345 0.0495)
+(-0.0030 0.0345 0.0495)
+(0.0000 0.0345 0.0495)
+(0.0030 0.0345 0.0495)
+(0.0060 0.0345 0.0495)
+(-0.0060 0.0375 0.0495)
+(-0.0030 0.0375 0.0495)
+(0.0000 0.0375 0.0495)
+(0.0030 0.0375 0.0495)
+(0.0060 0.0375 0.0495)
+(-0.0060 0.0405 0.0495)
+(-0.0030 0.0405 0.0495)
+(0.0000 0.0405 0.0495)
+(0.0030 0.0405 0.0495)
+(0.0060 0.0405 0.0495)
+(-0.0060 0.0435 0.0495)
+(-0.0030 0.0435 0.0495)
+(0.0000 0.0435 0.0495)
+(0.0030 0.0435 0.0495)
+(0.0060 0.0435 0.0495)
+(-0.0060 0.0465 0.0495)
+(-0.0030 0.0465 0.0495)
+(0.0000 0.0465 0.0495)
+(0.0030 0.0465 0.0495)
+(0.0060 0.0465 0.0495)
+(-0.0060 0.0495 0.0495)
+(-0.0030 0.0495 0.0495)
+(0.0000 0.0495 0.0495)
+(0.0030 0.0495 0.0495)
+(0.0060 0.0495 0.0495)
+(-0.0060 0.0525 0.0495)
+(-0.0030 0.0525 0.0495)
+(0.0000 0.0525 0.0495)
+(0.0030 0.0525 0.0495)
+(0.0060 0.0525 0.0495)
+(-0.0060 0.0555 0.0495)
+(-0.0030 0.0555 0.0495)
+(0.0000 0.0555 0.0495)
+(0.0030 0.0555 0.0495)
+(0.0060 0.0555 0.0495)
+(-0.0060 0.0585 0.0495)
+(-0.0030 0.0585 0.0495)
+(0.0000 0.0585 0.0495)
+(0.0030 0.0585 0.0495)
+(0.0060 0.0585 0.0495)
+(-0.0060 0.0615 0.0495)
+(-0.0030 0.0615 0.0495)
+(0.0000 0.0615 0.0495)
+(0.0030 0.0615 0.0495)
+(0.0060 0.0615 0.0495)
+(-0.0060 0.0645 0.0495)
+(-0.0030 0.0645 0.0495)
+(0.0000 0.0645 0.0495)
+(0.0030 0.0645 0.0495)
+(0.0060 0.0645 0.0495)
+(-0.0060 0.0675 0.0495)
+(-0.0030 0.0675 0.0495)
+(0.0000 0.0675 0.0495)
+(0.0030 0.0675 0.0495)
+(0.0060 0.0675 0.0495)
+(-0.0060 0.0705 0.0495)
+(-0.0030 0.0705 0.0495)
+(0.0000 0.0705 0.0495)
+(0.0030 0.0705 0.0495)
+(0.0060 0.0705 0.0495)
+(-0.0060 0.0735 0.0495)
+(-0.0030 0.0735 0.0495)
+(0.0000 0.0735 0.0495)
+(0.0030 0.0735 0.0495)
+(0.0060 0.0735 0.0495)
+(-0.0060 -0.0735 0.0525)
+(-0.0030 -0.0735 0.0525)
+(0.0000 -0.0735 0.0525)
+(0.0030 -0.0735 0.0525)
+(0.0060 -0.0735 0.0525)
+(-0.0060 -0.0705 0.0525)
+(-0.0030 -0.0705 0.0525)
+(0.0000 -0.0705 0.0525)
+(0.0030 -0.0705 0.0525)
+(0.0060 -0.0705 0.0525)
+(-0.0060 -0.0675 0.0525)
+(-0.0030 -0.0675 0.0525)
+(0.0000 -0.0675 0.0525)
+(0.0030 -0.0675 0.0525)
+(0.0060 -0.0675 0.0525)
+(-0.0060 -0.0645 0.0525)
+(-0.0030 -0.0645 0.0525)
+(0.0000 -0.0645 0.0525)
+(0.0030 -0.0645 0.0525)
+(0.0060 -0.0645 0.0525)
+(-0.0060 -0.0615 0.0525)
+(-0.0030 -0.0615 0.0525)
+(0.0000 -0.0615 0.0525)
+(0.0030 -0.0615 0.0525)
+(0.0060 -0.0615 0.0525)
+(-0.0060 -0.0585 0.0525)
+(-0.0030 -0.0585 0.0525)
+(0.0000 -0.0585 0.0525)
+(0.0030 -0.0585 0.0525)
+(0.0060 -0.0585 0.0525)
+(-0.0060 -0.0555 0.0525)
+(-0.0030 -0.0555 0.0525)
+(0.0000 -0.0555 0.0525)
+(0.0030 -0.0555 0.0525)
+(0.0060 -0.0555 0.0525)
+(-0.0060 -0.0525 0.0525)
+(-0.0030 -0.0525 0.0525)
+(0.0000 -0.0525 0.0525)
+(0.0030 -0.0525 0.0525)
+(0.0060 -0.0525 0.0525)
+(-0.0060 -0.0495 0.0525)
+(-0.0030 -0.0495 0.0525)
+(0.0000 -0.0495 0.0525)
+(0.0030 -0.0495 0.0525)
+(0.0060 -0.0495 0.0525)
+(-0.0060 -0.0465 0.0525)
+(-0.0030 -0.0465 0.0525)
+(0.0000 -0.0465 0.0525)
+(0.0030 -0.0465 0.0525)
+(0.0060 -0.0465 0.0525)
+(-0.0060 -0.0435 0.0525)
+(-0.0030 -0.0435 0.0525)
+(0.0000 -0.0435 0.0525)
+(0.0030 -0.0435 0.0525)
+(0.0060 -0.0435 0.0525)
+(-0.0060 -0.0405 0.0525)
+(-0.0030 -0.0405 0.0525)
+(0.0000 -0.0405 0.0525)
+(0.0030 -0.0405 0.0525)
+(0.0060 -0.0405 0.0525)
+(-0.0060 -0.0375 0.0525)
+(-0.0030 -0.0375 0.0525)
+(0.0000 -0.0375 0.0525)
+(0.0030 -0.0375 0.0525)
+(0.0060 -0.0375 0.0525)
+(-0.0060 -0.0345 0.0525)
+(-0.0030 -0.0345 0.0525)
+(0.0000 -0.0345 0.0525)
+(0.0030 -0.0345 0.0525)
+(0.0060 -0.0345 0.0525)
+(-0.0060 -0.0315 0.0525)
+(-0.0030 -0.0315 0.0525)
+(0.0000 -0.0315 0.0525)
+(0.0030 -0.0315 0.0525)
+(0.0060 -0.0315 0.0525)
+(-0.0060 -0.0285 0.0525)
+(-0.0030 -0.0285 0.0525)
+(0.0000 -0.0285 0.0525)
+(0.0030 -0.0285 0.0525)
+(0.0060 -0.0285 0.0525)
+(-0.0060 -0.0255 0.0525)
+(-0.0030 -0.0255 0.0525)
+(0.0000 -0.0255 0.0525)
+(0.0030 -0.0255 0.0525)
+(0.0060 -0.0255 0.0525)
+(-0.0060 -0.0225 0.0525)
+(-0.0030 -0.0225 0.0525)
+(0.0000 -0.0225 0.0525)
+(0.0030 -0.0225 0.0525)
+(0.0060 -0.0225 0.0525)
+(-0.0060 -0.0195 0.0525)
+(-0.0030 -0.0195 0.0525)
+(0.0000 -0.0195 0.0525)
+(0.0030 -0.0195 0.0525)
+(0.0060 -0.0195 0.0525)
+(-0.0060 -0.0165 0.0525)
+(-0.0030 -0.0165 0.0525)
+(0.0000 -0.0165 0.0525)
+(0.0030 -0.0165 0.0525)
+(0.0060 -0.0165 0.0525)
+(-0.0060 -0.0135 0.0525)
+(-0.0030 -0.0135 0.0525)
+(0.0000 -0.0135 0.0525)
+(0.0030 -0.0135 0.0525)
+(0.0060 -0.0135 0.0525)
+(-0.0060 -0.0105 0.0525)
+(-0.0030 -0.0105 0.0525)
+(0.0000 -0.0105 0.0525)
+(0.0030 -0.0105 0.0525)
+(0.0060 -0.0105 0.0525)
+(-0.0060 -0.0075 0.0525)
+(-0.0030 -0.0075 0.0525)
+(0.0000 -0.0075 0.0525)
+(0.0030 -0.0075 0.0525)
+(0.0060 -0.0075 0.0525)
+(-0.0060 -0.0045 0.0525)
+(-0.0030 -0.0045 0.0525)
+(0.0000 -0.0045 0.0525)
+(0.0030 -0.0045 0.0525)
+(0.0060 -0.0045 0.0525)
+(-0.0060 -0.0015 0.0525)
+(-0.0030 -0.0015 0.0525)
+(0.0000 -0.0015 0.0525)
+(0.0030 -0.0015 0.0525)
+(0.0060 -0.0015 0.0525)
+(-0.0060 0.0015 0.0525)
+(-0.0030 0.0015 0.0525)
+(0.0000 0.0015 0.0525)
+(0.0030 0.0015 0.0525)
+(0.0060 0.0015 0.0525)
+(-0.0060 0.0045 0.0525)
+(-0.0030 0.0045 0.0525)
+(0.0000 0.0045 0.0525)
+(0.0030 0.0045 0.0525)
+(0.0060 0.0045 0.0525)
+(-0.0060 0.0075 0.0525)
+(-0.0030 0.0075 0.0525)
+(0.0000 0.0075 0.0525)
+(0.0030 0.0075 0.0525)
+(0.0060 0.0075 0.0525)
+(-0.0060 0.0105 0.0525)
+(-0.0030 0.0105 0.0525)
+(0.0000 0.0105 0.0525)
+(0.0030 0.0105 0.0525)
+(0.0060 0.0105 0.0525)
+(-0.0060 0.0135 0.0525)
+(-0.0030 0.0135 0.0525)
+(0.0000 0.0135 0.0525)
+(0.0030 0.0135 0.0525)
+(0.0060 0.0135 0.0525)
+(-0.0060 0.0165 0.0525)
+(-0.0030 0.0165 0.0525)
+(0.0000 0.0165 0.0525)
+(0.0030 0.0165 0.0525)
+(0.0060 0.0165 0.0525)
+(-0.0060 0.0195 0.0525)
+(-0.0030 0.0195 0.0525)
+(0.0000 0.0195 0.0525)
+(0.0030 0.0195 0.0525)
+(0.0060 0.0195 0.0525)
+(-0.0060 0.0225 0.0525)
+(-0.0030 0.0225 0.0525)
+(0.0000 0.0225 0.0525)
+(0.0030 0.0225 0.0525)
+(0.0060 0.0225 0.0525)
+(-0.0060 0.0255 0.0525)
+(-0.0030 0.0255 0.0525)
+(0.0000 0.0255 0.0525)
+(0.0030 0.0255 0.0525)
+(0.0060 0.0255 0.0525)
+(-0.0060 0.0285 0.0525)
+(-0.0030 0.0285 0.0525)
+(0.0000 0.0285 0.0525)
+(0.0030 0.0285 0.0525)
+(0.0060 0.0285 0.0525)
+(-0.0060 0.0315 0.0525)
+(-0.0030 0.0315 0.0525)
+(0.0000 0.0315 0.0525)
+(0.0030 0.0315 0.0525)
+(0.0060 0.0315 0.0525)
+(-0.0060 0.0345 0.0525)
+(-0.0030 0.0345 0.0525)
+(0.0000 0.0345 0.0525)
+(0.0030 0.0345 0.0525)
+(0.0060 0.0345 0.0525)
+(-0.0060 0.0375 0.0525)
+(-0.0030 0.0375 0.0525)
+(0.0000 0.0375 0.0525)
+(0.0030 0.0375 0.0525)
+(0.0060 0.0375 0.0525)
+(-0.0060 0.0405 0.0525)
+(-0.0030 0.0405 0.0525)
+(0.0000 0.0405 0.0525)
+(0.0030 0.0405 0.0525)
+(0.0060 0.0405 0.0525)
+(-0.0060 0.0435 0.0525)
+(-0.0030 0.0435 0.0525)
+(0.0000 0.0435 0.0525)
+(0.0030 0.0435 0.0525)
+(0.0060 0.0435 0.0525)
+(-0.0060 0.0465 0.0525)
+(-0.0030 0.0465 0.0525)
+(0.0000 0.0465 0.0525)
+(0.0030 0.0465 0.0525)
+(0.0060 0.0465 0.0525)
+(-0.0060 0.0495 0.0525)
+(-0.0030 0.0495 0.0525)
+(0.0000 0.0495 0.0525)
+(0.0030 0.0495 0.0525)
+(0.0060 0.0495 0.0525)
+(-0.0060 0.0525 0.0525)
+(-0.0030 0.0525 0.0525)
+(0.0000 0.0525 0.0525)
+(0.0030 0.0525 0.0525)
+(0.0060 0.0525 0.0525)
+(-0.0060 0.0555 0.0525)
+(-0.0030 0.0555 0.0525)
+(0.0000 0.0555 0.0525)
+(0.0030 0.0555 0.0525)
+(0.0060 0.0555 0.0525)
+(-0.0060 0.0585 0.0525)
+(-0.0030 0.0585 0.0525)
+(0.0000 0.0585 0.0525)
+(0.0030 0.0585 0.0525)
+(0.0060 0.0585 0.0525)
+(-0.0060 0.0615 0.0525)
+(-0.0030 0.0615 0.0525)
+(0.0000 0.0615 0.0525)
+(0.0030 0.0615 0.0525)
+(0.0060 0.0615 0.0525)
+(-0.0060 0.0645 0.0525)
+(-0.0030 0.0645 0.0525)
+(0.0000 0.0645 0.0525)
+(0.0030 0.0645 0.0525)
+(0.0060 0.0645 0.0525)
+(-0.0060 0.0675 0.0525)
+(-0.0030 0.0675 0.0525)
+(0.0000 0.0675 0.0525)
+(0.0030 0.0675 0.0525)
+(0.0060 0.0675 0.0525)
+(-0.0060 0.0705 0.0525)
+(-0.0030 0.0705 0.0525)
+(0.0000 0.0705 0.0525)
+(0.0030 0.0705 0.0525)
+(0.0060 0.0705 0.0525)
+(-0.0060 0.0735 0.0525)
+(-0.0030 0.0735 0.0525)
+(0.0000 0.0735 0.0525)
+(0.0030 0.0735 0.0525)
+(0.0060 0.0735 0.0525)
+(-0.0060 -0.0735 0.0555)
+(-0.0030 -0.0735 0.0555)
+(0.0000 -0.0735 0.0555)
+(0.0030 -0.0735 0.0555)
+(0.0060 -0.0735 0.0555)
+(-0.0060 -0.0705 0.0555)
+(-0.0030 -0.0705 0.0555)
+(0.0000 -0.0705 0.0555)
+(0.0030 -0.0705 0.0555)
+(0.0060 -0.0705 0.0555)
+(-0.0060 -0.0675 0.0555)
+(-0.0030 -0.0675 0.0555)
+(0.0000 -0.0675 0.0555)
+(0.0030 -0.0675 0.0555)
+(0.0060 -0.0675 0.0555)
+(-0.0060 -0.0645 0.0555)
+(-0.0030 -0.0645 0.0555)
+(0.0000 -0.0645 0.0555)
+(0.0030 -0.0645 0.0555)
+(0.0060 -0.0645 0.0555)
+(-0.0060 -0.0615 0.0555)
+(-0.0030 -0.0615 0.0555)
+(0.0000 -0.0615 0.0555)
+(0.0030 -0.0615 0.0555)
+(0.0060 -0.0615 0.0555)
+(-0.0060 -0.0585 0.0555)
+(-0.0030 -0.0585 0.0555)
+(0.0000 -0.0585 0.0555)
+(0.0030 -0.0585 0.0555)
+(0.0060 -0.0585 0.0555)
+(-0.0060 -0.0555 0.0555)
+(-0.0030 -0.0555 0.0555)
+(0.0000 -0.0555 0.0555)
+(0.0030 -0.0555 0.0555)
+(0.0060 -0.0555 0.0555)
+(-0.0060 -0.0525 0.0555)
+(-0.0030 -0.0525 0.0555)
+(0.0000 -0.0525 0.0555)
+(0.0030 -0.0525 0.0555)
+(0.0060 -0.0525 0.0555)
+(-0.0060 -0.0495 0.0555)
+(-0.0030 -0.0495 0.0555)
+(0.0000 -0.0495 0.0555)
+(0.0030 -0.0495 0.0555)
+(0.0060 -0.0495 0.0555)
+(-0.0060 -0.0465 0.0555)
+(-0.0030 -0.0465 0.0555)
+(0.0000 -0.0465 0.0555)
+(0.0030 -0.0465 0.0555)
+(0.0060 -0.0465 0.0555)
+(-0.0060 -0.0435 0.0555)
+(-0.0030 -0.0435 0.0555)
+(0.0000 -0.0435 0.0555)
+(0.0030 -0.0435 0.0555)
+(0.0060 -0.0435 0.0555)
+(-0.0060 -0.0405 0.0555)
+(-0.0030 -0.0405 0.0555)
+(0.0000 -0.0405 0.0555)
+(0.0030 -0.0405 0.0555)
+(0.0060 -0.0405 0.0555)
+(-0.0060 -0.0375 0.0555)
+(-0.0030 -0.0375 0.0555)
+(0.0000 -0.0375 0.0555)
+(0.0030 -0.0375 0.0555)
+(0.0060 -0.0375 0.0555)
+(-0.0060 -0.0345 0.0555)
+(-0.0030 -0.0345 0.0555)
+(0.0000 -0.0345 0.0555)
+(0.0030 -0.0345 0.0555)
+(0.0060 -0.0345 0.0555)
+(-0.0060 -0.0315 0.0555)
+(-0.0030 -0.0315 0.0555)
+(0.0000 -0.0315 0.0555)
+(0.0030 -0.0315 0.0555)
+(0.0060 -0.0315 0.0555)
+(-0.0060 -0.0285 0.0555)
+(-0.0030 -0.0285 0.0555)
+(0.0000 -0.0285 0.0555)
+(0.0030 -0.0285 0.0555)
+(0.0060 -0.0285 0.0555)
+(-0.0060 -0.0255 0.0555)
+(-0.0030 -0.0255 0.0555)
+(0.0000 -0.0255 0.0555)
+(0.0030 -0.0255 0.0555)
+(0.0060 -0.0255 0.0555)
+(-0.0060 -0.0225 0.0555)
+(-0.0030 -0.0225 0.0555)
+(0.0000 -0.0225 0.0555)
+(0.0030 -0.0225 0.0555)
+(0.0060 -0.0225 0.0555)
+(-0.0060 -0.0195 0.0555)
+(-0.0030 -0.0195 0.0555)
+(0.0000 -0.0195 0.0555)
+(0.0030 -0.0195 0.0555)
+(0.0060 -0.0195 0.0555)
+(-0.0060 -0.0165 0.0555)
+(-0.0030 -0.0165 0.0555)
+(0.0000 -0.0165 0.0555)
+(0.0030 -0.0165 0.0555)
+(0.0060 -0.0165 0.0555)
+(-0.0060 -0.0135 0.0555)
+(-0.0030 -0.0135 0.0555)
+(0.0000 -0.0135 0.0555)
+(0.0030 -0.0135 0.0555)
+(0.0060 -0.0135 0.0555)
+(-0.0060 -0.0105 0.0555)
+(-0.0030 -0.0105 0.0555)
+(0.0000 -0.0105 0.0555)
+(0.0030 -0.0105 0.0555)
+(0.0060 -0.0105 0.0555)
+(-0.0060 -0.0075 0.0555)
+(-0.0030 -0.0075 0.0555)
+(0.0000 -0.0075 0.0555)
+(0.0030 -0.0075 0.0555)
+(0.0060 -0.0075 0.0555)
+(-0.0060 -0.0045 0.0555)
+(-0.0030 -0.0045 0.0555)
+(0.0000 -0.0045 0.0555)
+(0.0030 -0.0045 0.0555)
+(0.0060 -0.0045 0.0555)
+(-0.0060 -0.0015 0.0555)
+(-0.0030 -0.0015 0.0555)
+(0.0000 -0.0015 0.0555)
+(0.0030 -0.0015 0.0555)
+(0.0060 -0.0015 0.0555)
+(-0.0060 0.0015 0.0555)
+(-0.0030 0.0015 0.0555)
+(0.0000 0.0015 0.0555)
+(0.0030 0.0015 0.0555)
+(0.0060 0.0015 0.0555)
+(-0.0060 0.0045 0.0555)
+(-0.0030 0.0045 0.0555)
+(0.0000 0.0045 0.0555)
+(0.0030 0.0045 0.0555)
+(0.0060 0.0045 0.0555)
+(-0.0060 0.0075 0.0555)
+(-0.0030 0.0075 0.0555)
+(0.0000 0.0075 0.0555)
+(0.0030 0.0075 0.0555)
+(0.0060 0.0075 0.0555)
+(-0.0060 0.0105 0.0555)
+(-0.0030 0.0105 0.0555)
+(0.0000 0.0105 0.0555)
+(0.0030 0.0105 0.0555)
+(0.0060 0.0105 0.0555)
+(-0.0060 0.0135 0.0555)
+(-0.0030 0.0135 0.0555)
+(0.0000 0.0135 0.0555)
+(0.0030 0.0135 0.0555)
+(0.0060 0.0135 0.0555)
+(-0.0060 0.0165 0.0555)
+(-0.0030 0.0165 0.0555)
+(0.0000 0.0165 0.0555)
+(0.0030 0.0165 0.0555)
+(0.0060 0.0165 0.0555)
+(-0.0060 0.0195 0.0555)
+(-0.0030 0.0195 0.0555)
+(0.0000 0.0195 0.0555)
+(0.0030 0.0195 0.0555)
+(0.0060 0.0195 0.0555)
+(-0.0060 0.0225 0.0555)
+(-0.0030 0.0225 0.0555)
+(0.0000 0.0225 0.0555)
+(0.0030 0.0225 0.0555)
+(0.0060 0.0225 0.0555)
+(-0.0060 0.0255 0.0555)
+(-0.0030 0.0255 0.0555)
+(0.0000 0.0255 0.0555)
+(0.0030 0.0255 0.0555)
+(0.0060 0.0255 0.0555)
+(-0.0060 0.0285 0.0555)
+(-0.0030 0.0285 0.0555)
+(0.0000 0.0285 0.0555)
+(0.0030 0.0285 0.0555)
+(0.0060 0.0285 0.0555)
+(-0.0060 0.0315 0.0555)
+(-0.0030 0.0315 0.0555)
+(0.0000 0.0315 0.0555)
+(0.0030 0.0315 0.0555)
+(0.0060 0.0315 0.0555)
+(-0.0060 0.0345 0.0555)
+(-0.0030 0.0345 0.0555)
+(0.0000 0.0345 0.0555)
+(0.0030 0.0345 0.0555)
+(0.0060 0.0345 0.0555)
+(-0.0060 0.0375 0.0555)
+(-0.0030 0.0375 0.0555)
+(0.0000 0.0375 0.0555)
+(0.0030 0.0375 0.0555)
+(0.0060 0.0375 0.0555)
+(-0.0060 0.0405 0.0555)
+(-0.0030 0.0405 0.0555)
+(0.0000 0.0405 0.0555)
+(0.0030 0.0405 0.0555)
+(0.0060 0.0405 0.0555)
+(-0.0060 0.0435 0.0555)
+(-0.0030 0.0435 0.0555)
+(0.0000 0.0435 0.0555)
+(0.0030 0.0435 0.0555)
+(0.0060 0.0435 0.0555)
+(-0.0060 0.0465 0.0555)
+(-0.0030 0.0465 0.0555)
+(0.0000 0.0465 0.0555)
+(0.0030 0.0465 0.0555)
+(0.0060 0.0465 0.0555)
+(-0.0060 0.0495 0.0555)
+(-0.0030 0.0495 0.0555)
+(0.0000 0.0495 0.0555)
+(0.0030 0.0495 0.0555)
+(0.0060 0.0495 0.0555)
+(-0.0060 0.0525 0.0555)
+(-0.0030 0.0525 0.0555)
+(0.0000 0.0525 0.0555)
+(0.0030 0.0525 0.0555)
+(0.0060 0.0525 0.0555)
+(-0.0060 0.0555 0.0555)
+(-0.0030 0.0555 0.0555)
+(0.0000 0.0555 0.0555)
+(0.0030 0.0555 0.0555)
+(0.0060 0.0555 0.0555)
+(-0.0060 0.0585 0.0555)
+(-0.0030 0.0585 0.0555)
+(0.0000 0.0585 0.0555)
+(0.0030 0.0585 0.0555)
+(0.0060 0.0585 0.0555)
+(-0.0060 0.0615 0.0555)
+(-0.0030 0.0615 0.0555)
+(0.0000 0.0615 0.0555)
+(0.0030 0.0615 0.0555)
+(0.0060 0.0615 0.0555)
+(-0.0060 0.0645 0.0555)
+(-0.0030 0.0645 0.0555)
+(0.0000 0.0645 0.0555)
+(0.0030 0.0645 0.0555)
+(0.0060 0.0645 0.0555)
+(-0.0060 0.0675 0.0555)
+(-0.0030 0.0675 0.0555)
+(0.0000 0.0675 0.0555)
+(0.0030 0.0675 0.0555)
+(0.0060 0.0675 0.0555)
+(-0.0060 0.0705 0.0555)
+(-0.0030 0.0705 0.0555)
+(0.0000 0.0705 0.0555)
+(0.0030 0.0705 0.0555)
+(0.0060 0.0705 0.0555)
+(-0.0060 0.0735 0.0555)
+(-0.0030 0.0735 0.0555)
+(0.0000 0.0735 0.0555)
+(0.0030 0.0735 0.0555)
+(0.0060 0.0735 0.0555)
+(-0.0060 -0.0735 0.0585)
+(-0.0030 -0.0735 0.0585)
+(0.0000 -0.0735 0.0585)
+(0.0030 -0.0735 0.0585)
+(0.0060 -0.0735 0.0585)
+(-0.0060 -0.0705 0.0585)
+(-0.0030 -0.0705 0.0585)
+(0.0000 -0.0705 0.0585)
+(0.0030 -0.0705 0.0585)
+(0.0060 -0.0705 0.0585)
+(-0.0060 -0.0675 0.0585)
+(-0.0030 -0.0675 0.0585)
+(0.0000 -0.0675 0.0585)
+(0.0030 -0.0675 0.0585)
+(0.0060 -0.0675 0.0585)
+(-0.0060 -0.0645 0.0585)
+(-0.0030 -0.0645 0.0585)
+(0.0000 -0.0645 0.0585)
+(0.0030 -0.0645 0.0585)
+(0.0060 -0.0645 0.0585)
+(-0.0060 -0.0615 0.0585)
+(-0.0030 -0.0615 0.0585)
+(0.0000 -0.0615 0.0585)
+(0.0030 -0.0615 0.0585)
+(0.0060 -0.0615 0.0585)
+(-0.0060 -0.0585 0.0585)
+(-0.0030 -0.0585 0.0585)
+(0.0000 -0.0585 0.0585)
+(0.0030 -0.0585 0.0585)
+(0.0060 -0.0585 0.0585)
+(-0.0060 -0.0555 0.0585)
+(-0.0030 -0.0555 0.0585)
+(0.0000 -0.0555 0.0585)
+(0.0030 -0.0555 0.0585)
+(0.0060 -0.0555 0.0585)
+(-0.0060 -0.0525 0.0585)
+(-0.0030 -0.0525 0.0585)
+(0.0000 -0.0525 0.0585)
+(0.0030 -0.0525 0.0585)
+(0.0060 -0.0525 0.0585)
+(-0.0060 -0.0495 0.0585)
+(-0.0030 -0.0495 0.0585)
+(0.0000 -0.0495 0.0585)
+(0.0030 -0.0495 0.0585)
+(0.0060 -0.0495 0.0585)
+(-0.0060 -0.0465 0.0585)
+(-0.0030 -0.0465 0.0585)
+(0.0000 -0.0465 0.0585)
+(0.0030 -0.0465 0.0585)
+(0.0060 -0.0465 0.0585)
+(-0.0060 -0.0435 0.0585)
+(-0.0030 -0.0435 0.0585)
+(0.0000 -0.0435 0.0585)
+(0.0030 -0.0435 0.0585)
+(0.0060 -0.0435 0.0585)
+(-0.0060 -0.0405 0.0585)
+(-0.0030 -0.0405 0.0585)
+(0.0000 -0.0405 0.0585)
+(0.0030 -0.0405 0.0585)
+(0.0060 -0.0405 0.0585)
+(-0.0060 -0.0375 0.0585)
+(-0.0030 -0.0375 0.0585)
+(0.0000 -0.0375 0.0585)
+(0.0030 -0.0375 0.0585)
+(0.0060 -0.0375 0.0585)
+(-0.0060 -0.0345 0.0585)
+(-0.0030 -0.0345 0.0585)
+(0.0000 -0.0345 0.0585)
+(0.0030 -0.0345 0.0585)
+(0.0060 -0.0345 0.0585)
+(-0.0060 -0.0315 0.0585)
+(-0.0030 -0.0315 0.0585)
+(0.0000 -0.0315 0.0585)
+(0.0030 -0.0315 0.0585)
+(0.0060 -0.0315 0.0585)
+(-0.0060 -0.0285 0.0585)
+(-0.0030 -0.0285 0.0585)
+(0.0000 -0.0285 0.0585)
+(0.0030 -0.0285 0.0585)
+(0.0060 -0.0285 0.0585)
+(-0.0060 -0.0255 0.0585)
+(-0.0030 -0.0255 0.0585)
+(0.0000 -0.0255 0.0585)
+(0.0030 -0.0255 0.0585)
+(0.0060 -0.0255 0.0585)
+(-0.0060 -0.0225 0.0585)
+(-0.0030 -0.0225 0.0585)
+(0.0000 -0.0225 0.0585)
+(0.0030 -0.0225 0.0585)
+(0.0060 -0.0225 0.0585)
+(-0.0060 -0.0195 0.0585)
+(-0.0030 -0.0195 0.0585)
+(0.0000 -0.0195 0.0585)
+(0.0030 -0.0195 0.0585)
+(0.0060 -0.0195 0.0585)
+(-0.0060 -0.0165 0.0585)
+(-0.0030 -0.0165 0.0585)
+(0.0000 -0.0165 0.0585)
+(0.0030 -0.0165 0.0585)
+(0.0060 -0.0165 0.0585)
+(-0.0060 -0.0135 0.0585)
+(-0.0030 -0.0135 0.0585)
+(0.0000 -0.0135 0.0585)
+(0.0030 -0.0135 0.0585)
+(0.0060 -0.0135 0.0585)
+(-0.0060 -0.0105 0.0585)
+(-0.0030 -0.0105 0.0585)
+(0.0000 -0.0105 0.0585)
+(0.0030 -0.0105 0.0585)
+(0.0060 -0.0105 0.0585)
+(-0.0060 -0.0075 0.0585)
+(-0.0030 -0.0075 0.0585)
+(0.0000 -0.0075 0.0585)
+(0.0030 -0.0075 0.0585)
+(0.0060 -0.0075 0.0585)
+(-0.0060 -0.0045 0.0585)
+(-0.0030 -0.0045 0.0585)
+(0.0000 -0.0045 0.0585)
+(0.0030 -0.0045 0.0585)
+(0.0060 -0.0045 0.0585)
+(-0.0060 -0.0015 0.0585)
+(-0.0030 -0.0015 0.0585)
+(0.0000 -0.0015 0.0585)
+(0.0030 -0.0015 0.0585)
+(0.0060 -0.0015 0.0585)
+(-0.0060 0.0015 0.0585)
+(-0.0030 0.0015 0.0585)
+(0.0000 0.0015 0.0585)
+(0.0030 0.0015 0.0585)
+(0.0060 0.0015 0.0585)
+(-0.0060 0.0045 0.0585)
+(-0.0030 0.0045 0.0585)
+(0.0000 0.0045 0.0585)
+(0.0030 0.0045 0.0585)
+(0.0060 0.0045 0.0585)
+(-0.0060 0.0075 0.0585)
+(-0.0030 0.0075 0.0585)
+(0.0000 0.0075 0.0585)
+(0.0030 0.0075 0.0585)
+(0.0060 0.0075 0.0585)
+(-0.0060 0.0105 0.0585)
+(-0.0030 0.0105 0.0585)
+(0.0000 0.0105 0.0585)
+(0.0030 0.0105 0.0585)
+(0.0060 0.0105 0.0585)
+(-0.0060 0.0135 0.0585)
+(-0.0030 0.0135 0.0585)
+(0.0000 0.0135 0.0585)
+(0.0030 0.0135 0.0585)
+(0.0060 0.0135 0.0585)
+(-0.0060 0.0165 0.0585)
+(-0.0030 0.0165 0.0585)
+(0.0000 0.0165 0.0585)
+(0.0030 0.0165 0.0585)
+(0.0060 0.0165 0.0585)
+(-0.0060 0.0195 0.0585)
+(-0.0030 0.0195 0.0585)
+(0.0000 0.0195 0.0585)
+(0.0030 0.0195 0.0585)
+(0.0060 0.0195 0.0585)
+(-0.0060 0.0225 0.0585)
+(-0.0030 0.0225 0.0585)
+(0.0000 0.0225 0.0585)
+(0.0030 0.0225 0.0585)
+(0.0060 0.0225 0.0585)
+(-0.0060 0.0255 0.0585)
+(-0.0030 0.0255 0.0585)
+(0.0000 0.0255 0.0585)
+(0.0030 0.0255 0.0585)
+(0.0060 0.0255 0.0585)
+(-0.0060 0.0285 0.0585)
+(-0.0030 0.0285 0.0585)
+(0.0000 0.0285 0.0585)
+(0.0030 0.0285 0.0585)
+(0.0060 0.0285 0.0585)
+(-0.0060 0.0315 0.0585)
+(-0.0030 0.0315 0.0585)
+(0.0000 0.0315 0.0585)
+(0.0030 0.0315 0.0585)
+(0.0060 0.0315 0.0585)
+(-0.0060 0.0345 0.0585)
+(-0.0030 0.0345 0.0585)
+(0.0000 0.0345 0.0585)
+(0.0030 0.0345 0.0585)
+(0.0060 0.0345 0.0585)
+(-0.0060 0.0375 0.0585)
+(-0.0030 0.0375 0.0585)
+(0.0000 0.0375 0.0585)
+(0.0030 0.0375 0.0585)
+(0.0060 0.0375 0.0585)
+(-0.0060 0.0405 0.0585)
+(-0.0030 0.0405 0.0585)
+(0.0000 0.0405 0.0585)
+(0.0030 0.0405 0.0585)
+(0.0060 0.0405 0.0585)
+(-0.0060 0.0435 0.0585)
+(-0.0030 0.0435 0.0585)
+(0.0000 0.0435 0.0585)
+(0.0030 0.0435 0.0585)
+(0.0060 0.0435 0.0585)
+(-0.0060 0.0465 0.0585)
+(-0.0030 0.0465 0.0585)
+(0.0000 0.0465 0.0585)
+(0.0030 0.0465 0.0585)
+(0.0060 0.0465 0.0585)
+(-0.0060 0.0495 0.0585)
+(-0.0030 0.0495 0.0585)
+(0.0000 0.0495 0.0585)
+(0.0030 0.0495 0.0585)
+(0.0060 0.0495 0.0585)
+(-0.0060 0.0525 0.0585)
+(-0.0030 0.0525 0.0585)
+(0.0000 0.0525 0.0585)
+(0.0030 0.0525 0.0585)
+(0.0060 0.0525 0.0585)
+(-0.0060 0.0555 0.0585)
+(-0.0030 0.0555 0.0585)
+(0.0000 0.0555 0.0585)
+(0.0030 0.0555 0.0585)
+(0.0060 0.0555 0.0585)
+(-0.0060 0.0585 0.0585)
+(-0.0030 0.0585 0.0585)
+(0.0000 0.0585 0.0585)
+(0.0030 0.0585 0.0585)
+(0.0060 0.0585 0.0585)
+(-0.0060 0.0615 0.0585)
+(-0.0030 0.0615 0.0585)
+(0.0000 0.0615 0.0585)
+(0.0030 0.0615 0.0585)
+(0.0060 0.0615 0.0585)
+(-0.0060 0.0645 0.0585)
+(-0.0030 0.0645 0.0585)
+(0.0000 0.0645 0.0585)
+(0.0030 0.0645 0.0585)
+(0.0060 0.0645 0.0585)
+(-0.0060 0.0675 0.0585)
+(-0.0030 0.0675 0.0585)
+(0.0000 0.0675 0.0585)
+(0.0030 0.0675 0.0585)
+(0.0060 0.0675 0.0585)
+(-0.0060 0.0705 0.0585)
+(-0.0030 0.0705 0.0585)
+(0.0000 0.0705 0.0585)
+(0.0030 0.0705 0.0585)
+(0.0060 0.0705 0.0585)
+(-0.0060 0.0735 0.0585)
+(-0.0030 0.0735 0.0585)
+(0.0000 0.0735 0.0585)
+(0.0030 0.0735 0.0585)
+(0.0060 0.0735 0.0585)
+(-0.0060 -0.0735 0.0615)
+(-0.0030 -0.0735 0.0615)
+(0.0000 -0.0735 0.0615)
+(0.0030 -0.0735 0.0615)
+(0.0060 -0.0735 0.0615)
+(-0.0060 -0.0705 0.0615)
+(-0.0030 -0.0705 0.0615)
+(0.0000 -0.0705 0.0615)
+(0.0030 -0.0705 0.0615)
+(0.0060 -0.0705 0.0615)
+(-0.0060 -0.0675 0.0615)
+(-0.0030 -0.0675 0.0615)
+(0.0000 -0.0675 0.0615)
+(0.0030 -0.0675 0.0615)
+(0.0060 -0.0675 0.0615)
+(-0.0060 -0.0645 0.0615)
+(-0.0030 -0.0645 0.0615)
+(0.0000 -0.0645 0.0615)
+(0.0030 -0.0645 0.0615)
+(0.0060 -0.0645 0.0615)
+(-0.0060 -0.0615 0.0615)
+(-0.0030 -0.0615 0.0615)
+(0.0000 -0.0615 0.0615)
+(0.0030 -0.0615 0.0615)
+(0.0060 -0.0615 0.0615)
+(-0.0060 -0.0585 0.0615)
+(-0.0030 -0.0585 0.0615)
+(0.0000 -0.0585 0.0615)
+(0.0030 -0.0585 0.0615)
+(0.0060 -0.0585 0.0615)
+(-0.0060 -0.0555 0.0615)
+(-0.0030 -0.0555 0.0615)
+(0.0000 -0.0555 0.0615)
+(0.0030 -0.0555 0.0615)
+(0.0060 -0.0555 0.0615)
+(-0.0060 -0.0525 0.0615)
+(-0.0030 -0.0525 0.0615)
+(0.0000 -0.0525 0.0615)
+(0.0030 -0.0525 0.0615)
+(0.0060 -0.0525 0.0615)
+(-0.0060 -0.0495 0.0615)
+(-0.0030 -0.0495 0.0615)
+(0.0000 -0.0495 0.0615)
+(0.0030 -0.0495 0.0615)
+(0.0060 -0.0495 0.0615)
+(-0.0060 -0.0465 0.0615)
+(-0.0030 -0.0465 0.0615)
+(0.0000 -0.0465 0.0615)
+(0.0030 -0.0465 0.0615)
+(0.0060 -0.0465 0.0615)
+(-0.0060 -0.0435 0.0615)
+(-0.0030 -0.0435 0.0615)
+(0.0000 -0.0435 0.0615)
+(0.0030 -0.0435 0.0615)
+(0.0060 -0.0435 0.0615)
+(-0.0060 -0.0405 0.0615)
+(-0.0030 -0.0405 0.0615)
+(0.0000 -0.0405 0.0615)
+(0.0030 -0.0405 0.0615)
+(0.0060 -0.0405 0.0615)
+(-0.0060 -0.0375 0.0615)
+(-0.0030 -0.0375 0.0615)
+(0.0000 -0.0375 0.0615)
+(0.0030 -0.0375 0.0615)
+(0.0060 -0.0375 0.0615)
+(-0.0060 -0.0345 0.0615)
+(-0.0030 -0.0345 0.0615)
+(0.0000 -0.0345 0.0615)
+(0.0030 -0.0345 0.0615)
+(0.0060 -0.0345 0.0615)
+(-0.0060 -0.0315 0.0615)
+(-0.0030 -0.0315 0.0615)
+(0.0000 -0.0315 0.0615)
+(0.0030 -0.0315 0.0615)
+(0.0060 -0.0315 0.0615)
+(-0.0060 -0.0285 0.0615)
+(-0.0030 -0.0285 0.0615)
+(0.0000 -0.0285 0.0615)
+(0.0030 -0.0285 0.0615)
+(0.0060 -0.0285 0.0615)
+(-0.0060 -0.0255 0.0615)
+(-0.0030 -0.0255 0.0615)
+(0.0000 -0.0255 0.0615)
+(0.0030 -0.0255 0.0615)
+(0.0060 -0.0255 0.0615)
+(-0.0060 -0.0225 0.0615)
+(-0.0030 -0.0225 0.0615)
+(0.0000 -0.0225 0.0615)
+(0.0030 -0.0225 0.0615)
+(0.0060 -0.0225 0.0615)
+(-0.0060 -0.0195 0.0615)
+(-0.0030 -0.0195 0.0615)
+(0.0000 -0.0195 0.0615)
+(0.0030 -0.0195 0.0615)
+(0.0060 -0.0195 0.0615)
+(-0.0060 -0.0165 0.0615)
+(-0.0030 -0.0165 0.0615)
+(0.0000 -0.0165 0.0615)
+(0.0030 -0.0165 0.0615)
+(0.0060 -0.0165 0.0615)
+(-0.0060 -0.0135 0.0615)
+(-0.0030 -0.0135 0.0615)
+(0.0000 -0.0135 0.0615)
+(0.0030 -0.0135 0.0615)
+(0.0060 -0.0135 0.0615)
+(-0.0060 -0.0105 0.0615)
+(-0.0030 -0.0105 0.0615)
+(0.0000 -0.0105 0.0615)
+(0.0030 -0.0105 0.0615)
+(0.0060 -0.0105 0.0615)
+(-0.0060 -0.0075 0.0615)
+(-0.0030 -0.0075 0.0615)
+(0.0000 -0.0075 0.0615)
+(0.0030 -0.0075 0.0615)
+(0.0060 -0.0075 0.0615)
+(-0.0060 -0.0045 0.0615)
+(-0.0030 -0.0045 0.0615)
+(0.0000 -0.0045 0.0615)
+(0.0030 -0.0045 0.0615)
+(0.0060 -0.0045 0.0615)
+(-0.0060 -0.0015 0.0615)
+(-0.0030 -0.0015 0.0615)
+(0.0000 -0.0015 0.0615)
+(0.0030 -0.0015 0.0615)
+(0.0060 -0.0015 0.0615)
+(-0.0060 0.0015 0.0615)
+(-0.0030 0.0015 0.0615)
+(0.0000 0.0015 0.0615)
+(0.0030 0.0015 0.0615)
+(0.0060 0.0015 0.0615)
+(-0.0060 0.0045 0.0615)
+(-0.0030 0.0045 0.0615)
+(0.0000 0.0045 0.0615)
+(0.0030 0.0045 0.0615)
+(0.0060 0.0045 0.0615)
+(-0.0060 0.0075 0.0615)
+(-0.0030 0.0075 0.0615)
+(0.0000 0.0075 0.0615)
+(0.0030 0.0075 0.0615)
+(0.0060 0.0075 0.0615)
+(-0.0060 0.0105 0.0615)
+(-0.0030 0.0105 0.0615)
+(0.0000 0.0105 0.0615)
+(0.0030 0.0105 0.0615)
+(0.0060 0.0105 0.0615)
+(-0.0060 0.0135 0.0615)
+(-0.0030 0.0135 0.0615)
+(0.0000 0.0135 0.0615)
+(0.0030 0.0135 0.0615)
+(0.0060 0.0135 0.0615)
+(-0.0060 0.0165 0.0615)
+(-0.0030 0.0165 0.0615)
+(0.0000 0.0165 0.0615)
+(0.0030 0.0165 0.0615)
+(0.0060 0.0165 0.0615)
+(-0.0060 0.0195 0.0615)
+(-0.0030 0.0195 0.0615)
+(0.0000 0.0195 0.0615)
+(0.0030 0.0195 0.0615)
+(0.0060 0.0195 0.0615)
+(-0.0060 0.0225 0.0615)
+(-0.0030 0.0225 0.0615)
+(0.0000 0.0225 0.0615)
+(0.0030 0.0225 0.0615)
+(0.0060 0.0225 0.0615)
+(-0.0060 0.0255 0.0615)
+(-0.0030 0.0255 0.0615)
+(0.0000 0.0255 0.0615)
+(0.0030 0.0255 0.0615)
+(0.0060 0.0255 0.0615)
+(-0.0060 0.0285 0.0615)
+(-0.0030 0.0285 0.0615)
+(0.0000 0.0285 0.0615)
+(0.0030 0.0285 0.0615)
+(0.0060 0.0285 0.0615)
+(-0.0060 0.0315 0.0615)
+(-0.0030 0.0315 0.0615)
+(0.0000 0.0315 0.0615)
+(0.0030 0.0315 0.0615)
+(0.0060 0.0315 0.0615)
+(-0.0060 0.0345 0.0615)
+(-0.0030 0.0345 0.0615)
+(0.0000 0.0345 0.0615)
+(0.0030 0.0345 0.0615)
+(0.0060 0.0345 0.0615)
+(-0.0060 0.0375 0.0615)
+(-0.0030 0.0375 0.0615)
+(0.0000 0.0375 0.0615)
+(0.0030 0.0375 0.0615)
+(0.0060 0.0375 0.0615)
+(-0.0060 0.0405 0.0615)
+(-0.0030 0.0405 0.0615)
+(0.0000 0.0405 0.0615)
+(0.0030 0.0405 0.0615)
+(0.0060 0.0405 0.0615)
+(-0.0060 0.0435 0.0615)
+(-0.0030 0.0435 0.0615)
+(0.0000 0.0435 0.0615)
+(0.0030 0.0435 0.0615)
+(0.0060 0.0435 0.0615)
+(-0.0060 0.0465 0.0615)
+(-0.0030 0.0465 0.0615)
+(0.0000 0.0465 0.0615)
+(0.0030 0.0465 0.0615)
+(0.0060 0.0465 0.0615)
+(-0.0060 0.0495 0.0615)
+(-0.0030 0.0495 0.0615)
+(0.0000 0.0495 0.0615)
+(0.0030 0.0495 0.0615)
+(0.0060 0.0495 0.0615)
+(-0.0060 0.0525 0.0615)
+(-0.0030 0.0525 0.0615)
+(0.0000 0.0525 0.0615)
+(0.0030 0.0525 0.0615)
+(0.0060 0.0525 0.0615)
+(-0.0060 0.0555 0.0615)
+(-0.0030 0.0555 0.0615)
+(0.0000 0.0555 0.0615)
+(0.0030 0.0555 0.0615)
+(0.0060 0.0555 0.0615)
+(-0.0060 0.0585 0.0615)
+(-0.0030 0.0585 0.0615)
+(0.0000 0.0585 0.0615)
+(0.0030 0.0585 0.0615)
+(0.0060 0.0585 0.0615)
+(-0.0060 0.0615 0.0615)
+(-0.0030 0.0615 0.0615)
+(0.0000 0.0615 0.0615)
+(0.0030 0.0615 0.0615)
+(0.0060 0.0615 0.0615)
+(-0.0060 0.0645 0.0615)
+(-0.0030 0.0645 0.0615)
+(0.0000 0.0645 0.0615)
+(0.0030 0.0645 0.0615)
+(0.0060 0.0645 0.0615)
+(-0.0060 0.0675 0.0615)
+(-0.0030 0.0675 0.0615)
+(0.0000 0.0675 0.0615)
+(0.0030 0.0675 0.0615)
+(0.0060 0.0675 0.0615)
+(-0.0060 0.0705 0.0615)
+(-0.0030 0.0705 0.0615)
+(0.0000 0.0705 0.0615)
+(0.0030 0.0705 0.0615)
+(0.0060 0.0705 0.0615)
+(-0.0060 0.0735 0.0615)
+(-0.0030 0.0735 0.0615)
+(0.0000 0.0735 0.0615)
+(0.0030 0.0735 0.0615)
+(0.0060 0.0735 0.0615)
+(-0.0060 -0.0735 0.0645)
+(-0.0030 -0.0735 0.0645)
+(0.0000 -0.0735 0.0645)
+(0.0030 -0.0735 0.0645)
+(0.0060 -0.0735 0.0645)
+(-0.0060 -0.0705 0.0645)
+(-0.0030 -0.0705 0.0645)
+(0.0000 -0.0705 0.0645)
+(0.0030 -0.0705 0.0645)
+(0.0060 -0.0705 0.0645)
+(-0.0060 -0.0675 0.0645)
+(-0.0030 -0.0675 0.0645)
+(0.0000 -0.0675 0.0645)
+(0.0030 -0.0675 0.0645)
+(0.0060 -0.0675 0.0645)
+(-0.0060 -0.0645 0.0645)
+(-0.0030 -0.0645 0.0645)
+(0.0000 -0.0645 0.0645)
+(0.0030 -0.0645 0.0645)
+(0.0060 -0.0645 0.0645)
+(-0.0060 -0.0615 0.0645)
+(-0.0030 -0.0615 0.0645)
+(0.0000 -0.0615 0.0645)
+(0.0030 -0.0615 0.0645)
+(0.0060 -0.0615 0.0645)
+(-0.0060 -0.0585 0.0645)
+(-0.0030 -0.0585 0.0645)
+(0.0000 -0.0585 0.0645)
+(0.0030 -0.0585 0.0645)
+(0.0060 -0.0585 0.0645)
+(-0.0060 -0.0555 0.0645)
+(-0.0030 -0.0555 0.0645)
+(0.0000 -0.0555 0.0645)
+(0.0030 -0.0555 0.0645)
+(0.0060 -0.0555 0.0645)
+(-0.0060 -0.0525 0.0645)
+(-0.0030 -0.0525 0.0645)
+(0.0000 -0.0525 0.0645)
+(0.0030 -0.0525 0.0645)
+(0.0060 -0.0525 0.0645)
+(-0.0060 -0.0495 0.0645)
+(-0.0030 -0.0495 0.0645)
+(0.0000 -0.0495 0.0645)
+(0.0030 -0.0495 0.0645)
+(0.0060 -0.0495 0.0645)
+(-0.0060 -0.0465 0.0645)
+(-0.0030 -0.0465 0.0645)
+(0.0000 -0.0465 0.0645)
+(0.0030 -0.0465 0.0645)
+(0.0060 -0.0465 0.0645)
+(-0.0060 -0.0435 0.0645)
+(-0.0030 -0.0435 0.0645)
+(0.0000 -0.0435 0.0645)
+(0.0030 -0.0435 0.0645)
+(0.0060 -0.0435 0.0645)
+(-0.0060 -0.0405 0.0645)
+(-0.0030 -0.0405 0.0645)
+(0.0000 -0.0405 0.0645)
+(0.0030 -0.0405 0.0645)
+(0.0060 -0.0405 0.0645)
+(-0.0060 -0.0375 0.0645)
+(-0.0030 -0.0375 0.0645)
+(0.0000 -0.0375 0.0645)
+(0.0030 -0.0375 0.0645)
+(0.0060 -0.0375 0.0645)
+(-0.0060 -0.0345 0.0645)
+(-0.0030 -0.0345 0.0645)
+(0.0000 -0.0345 0.0645)
+(0.0030 -0.0345 0.0645)
+(0.0060 -0.0345 0.0645)
+(-0.0060 -0.0315 0.0645)
+(-0.0030 -0.0315 0.0645)
+(0.0000 -0.0315 0.0645)
+(0.0030 -0.0315 0.0645)
+(0.0060 -0.0315 0.0645)
+(-0.0060 -0.0285 0.0645)
+(-0.0030 -0.0285 0.0645)
+(0.0000 -0.0285 0.0645)
+(0.0030 -0.0285 0.0645)
+(0.0060 -0.0285 0.0645)
+(-0.0060 -0.0255 0.0645)
+(-0.0030 -0.0255 0.0645)
+(0.0000 -0.0255 0.0645)
+(0.0030 -0.0255 0.0645)
+(0.0060 -0.0255 0.0645)
+(-0.0060 -0.0225 0.0645)
+(-0.0030 -0.0225 0.0645)
+(0.0000 -0.0225 0.0645)
+(0.0030 -0.0225 0.0645)
+(0.0060 -0.0225 0.0645)
+(-0.0060 -0.0195 0.0645)
+(-0.0030 -0.0195 0.0645)
+(0.0000 -0.0195 0.0645)
+(0.0030 -0.0195 0.0645)
+(0.0060 -0.0195 0.0645)
+(-0.0060 -0.0165 0.0645)
+(-0.0030 -0.0165 0.0645)
+(0.0000 -0.0165 0.0645)
+(0.0030 -0.0165 0.0645)
+(0.0060 -0.0165 0.0645)
+(-0.0060 -0.0135 0.0645)
+(-0.0030 -0.0135 0.0645)
+(0.0000 -0.0135 0.0645)
+(0.0030 -0.0135 0.0645)
+(0.0060 -0.0135 0.0645)
+(-0.0060 -0.0105 0.0645)
+(-0.0030 -0.0105 0.0645)
+(0.0000 -0.0105 0.0645)
+(0.0030 -0.0105 0.0645)
+(0.0060 -0.0105 0.0645)
+(-0.0060 -0.0075 0.0645)
+(-0.0030 -0.0075 0.0645)
+(0.0000 -0.0075 0.0645)
+(0.0030 -0.0075 0.0645)
+(0.0060 -0.0075 0.0645)
+(-0.0060 -0.0045 0.0645)
+(-0.0030 -0.0045 0.0645)
+(0.0000 -0.0045 0.0645)
+(0.0030 -0.0045 0.0645)
+(0.0060 -0.0045 0.0645)
+(-0.0060 -0.0015 0.0645)
+(-0.0030 -0.0015 0.0645)
+(0.0000 -0.0015 0.0645)
+(0.0030 -0.0015 0.0645)
+(0.0060 -0.0015 0.0645)
+(-0.0060 0.0015 0.0645)
+(-0.0030 0.0015 0.0645)
+(0.0000 0.0015 0.0645)
+(0.0030 0.0015 0.0645)
+(0.0060 0.0015 0.0645)
+(-0.0060 0.0045 0.0645)
+(-0.0030 0.0045 0.0645)
+(0.0000 0.0045 0.0645)
+(0.0030 0.0045 0.0645)
+(0.0060 0.0045 0.0645)
+(-0.0060 0.0075 0.0645)
+(-0.0030 0.0075 0.0645)
+(0.0000 0.0075 0.0645)
+(0.0030 0.0075 0.0645)
+(0.0060 0.0075 0.0645)
+(-0.0060 0.0105 0.0645)
+(-0.0030 0.0105 0.0645)
+(0.0000 0.0105 0.0645)
+(0.0030 0.0105 0.0645)
+(0.0060 0.0105 0.0645)
+(-0.0060 0.0135 0.0645)
+(-0.0030 0.0135 0.0645)
+(0.0000 0.0135 0.0645)
+(0.0030 0.0135 0.0645)
+(0.0060 0.0135 0.0645)
+(-0.0060 0.0165 0.0645)
+(-0.0030 0.0165 0.0645)
+(0.0000 0.0165 0.0645)
+(0.0030 0.0165 0.0645)
+(0.0060 0.0165 0.0645)
+(-0.0060 0.0195 0.0645)
+(-0.0030 0.0195 0.0645)
+(0.0000 0.0195 0.0645)
+(0.0030 0.0195 0.0645)
+(0.0060 0.0195 0.0645)
+(-0.0060 0.0225 0.0645)
+(-0.0030 0.0225 0.0645)
+(0.0000 0.0225 0.0645)
+(0.0030 0.0225 0.0645)
+(0.0060 0.0225 0.0645)
+(-0.0060 0.0255 0.0645)
+(-0.0030 0.0255 0.0645)
+(0.0000 0.0255 0.0645)
+(0.0030 0.0255 0.0645)
+(0.0060 0.0255 0.0645)
+(-0.0060 0.0285 0.0645)
+(-0.0030 0.0285 0.0645)
+(0.0000 0.0285 0.0645)
+(0.0030 0.0285 0.0645)
+(0.0060 0.0285 0.0645)
+(-0.0060 0.0315 0.0645)
+(-0.0030 0.0315 0.0645)
+(0.0000 0.0315 0.0645)
+(0.0030 0.0315 0.0645)
+(0.0060 0.0315 0.0645)
+(-0.0060 0.0345 0.0645)
+(-0.0030 0.0345 0.0645)
+(0.0000 0.0345 0.0645)
+(0.0030 0.0345 0.0645)
+(0.0060 0.0345 0.0645)
+(-0.0060 0.0375 0.0645)
+(-0.0030 0.0375 0.0645)
+(0.0000 0.0375 0.0645)
+(0.0030 0.0375 0.0645)
+(0.0060 0.0375 0.0645)
+(-0.0060 0.0405 0.0645)
+(-0.0030 0.0405 0.0645)
+(0.0000 0.0405 0.0645)
+(0.0030 0.0405 0.0645)
+(0.0060 0.0405 0.0645)
+(-0.0060 0.0435 0.0645)
+(-0.0030 0.0435 0.0645)
+(0.0000 0.0435 0.0645)
+(0.0030 0.0435 0.0645)
+(0.0060 0.0435 0.0645)
+(-0.0060 0.0465 0.0645)
+(-0.0030 0.0465 0.0645)
+(0.0000 0.0465 0.0645)
+(0.0030 0.0465 0.0645)
+(0.0060 0.0465 0.0645)
+(-0.0060 0.0495 0.0645)
+(-0.0030 0.0495 0.0645)
+(0.0000 0.0495 0.0645)
+(0.0030 0.0495 0.0645)
+(0.0060 0.0495 0.0645)
+(-0.0060 0.0525 0.0645)
+(-0.0030 0.0525 0.0645)
+(0.0000 0.0525 0.0645)
+(0.0030 0.0525 0.0645)
+(0.0060 0.0525 0.0645)
+(-0.0060 0.0555 0.0645)
+(-0.0030 0.0555 0.0645)
+(0.0000 0.0555 0.0645)
+(0.0030 0.0555 0.0645)
+(0.0060 0.0555 0.0645)
+(-0.0060 0.0585 0.0645)
+(-0.0030 0.0585 0.0645)
+(0.0000 0.0585 0.0645)
+(0.0030 0.0585 0.0645)
+(0.0060 0.0585 0.0645)
+(-0.0060 0.0615 0.0645)
+(-0.0030 0.0615 0.0645)
+(0.0000 0.0615 0.0645)
+(0.0030 0.0615 0.0645)
+(0.0060 0.0615 0.0645)
+(-0.0060 0.0645 0.0645)
+(-0.0030 0.0645 0.0645)
+(0.0000 0.0645 0.0645)
+(0.0030 0.0645 0.0645)
+(0.0060 0.0645 0.0645)
+(-0.0060 0.0675 0.0645)
+(-0.0030 0.0675 0.0645)
+(0.0000 0.0675 0.0645)
+(0.0030 0.0675 0.0645)
+(0.0060 0.0675 0.0645)
+(-0.0060 0.0705 0.0645)
+(-0.0030 0.0705 0.0645)
+(0.0000 0.0705 0.0645)
+(0.0030 0.0705 0.0645)
+(0.0060 0.0705 0.0645)
+(-0.0060 0.0735 0.0645)
+(-0.0030 0.0735 0.0645)
+(0.0000 0.0735 0.0645)
+(0.0030 0.0735 0.0645)
+(0.0060 0.0735 0.0645)
+(-0.0060 -0.0735 0.0675)
+(-0.0030 -0.0735 0.0675)
+(0.0000 -0.0735 0.0675)
+(0.0030 -0.0735 0.0675)
+(0.0060 -0.0735 0.0675)
+(-0.0060 -0.0705 0.0675)
+(-0.0030 -0.0705 0.0675)
+(0.0000 -0.0705 0.0675)
+(0.0030 -0.0705 0.0675)
+(0.0060 -0.0705 0.0675)
+(-0.0060 -0.0675 0.0675)
+(-0.0030 -0.0675 0.0675)
+(0.0000 -0.0675 0.0675)
+(0.0030 -0.0675 0.0675)
+(0.0060 -0.0675 0.0675)
+(-0.0060 -0.0645 0.0675)
+(-0.0030 -0.0645 0.0675)
+(0.0000 -0.0645 0.0675)
+(0.0030 -0.0645 0.0675)
+(0.0060 -0.0645 0.0675)
+(-0.0060 -0.0615 0.0675)
+(-0.0030 -0.0615 0.0675)
+(0.0000 -0.0615 0.0675)
+(0.0030 -0.0615 0.0675)
+(0.0060 -0.0615 0.0675)
+(-0.0060 -0.0585 0.0675)
+(-0.0030 -0.0585 0.0675)
+(0.0000 -0.0585 0.0675)
+(0.0030 -0.0585 0.0675)
+(0.0060 -0.0585 0.0675)
+(-0.0060 -0.0555 0.0675)
+(-0.0030 -0.0555 0.0675)
+(0.0000 -0.0555 0.0675)
+(0.0030 -0.0555 0.0675)
+(0.0060 -0.0555 0.0675)
+(-0.0060 -0.0525 0.0675)
+(-0.0030 -0.0525 0.0675)
+(0.0000 -0.0525 0.0675)
+(0.0030 -0.0525 0.0675)
+(0.0060 -0.0525 0.0675)
+(-0.0060 -0.0495 0.0675)
+(-0.0030 -0.0495 0.0675)
+(0.0000 -0.0495 0.0675)
+(0.0030 -0.0495 0.0675)
+(0.0060 -0.0495 0.0675)
+(-0.0060 -0.0465 0.0675)
+(-0.0030 -0.0465 0.0675)
+(0.0000 -0.0465 0.0675)
+(0.0030 -0.0465 0.0675)
+(0.0060 -0.0465 0.0675)
+(-0.0060 -0.0435 0.0675)
+(-0.0030 -0.0435 0.0675)
+(0.0000 -0.0435 0.0675)
+(0.0030 -0.0435 0.0675)
+(0.0060 -0.0435 0.0675)
+(-0.0060 -0.0405 0.0675)
+(-0.0030 -0.0405 0.0675)
+(0.0000 -0.0405 0.0675)
+(0.0030 -0.0405 0.0675)
+(0.0060 -0.0405 0.0675)
+(-0.0060 -0.0375 0.0675)
+(-0.0030 -0.0375 0.0675)
+(0.0000 -0.0375 0.0675)
+(0.0030 -0.0375 0.0675)
+(0.0060 -0.0375 0.0675)
+(-0.0060 -0.0345 0.0675)
+(-0.0030 -0.0345 0.0675)
+(0.0000 -0.0345 0.0675)
+(0.0030 -0.0345 0.0675)
+(0.0060 -0.0345 0.0675)
+(-0.0060 -0.0315 0.0675)
+(-0.0030 -0.0315 0.0675)
+(0.0000 -0.0315 0.0675)
+(0.0030 -0.0315 0.0675)
+(0.0060 -0.0315 0.0675)
+(-0.0060 -0.0285 0.0675)
+(-0.0030 -0.0285 0.0675)
+(0.0000 -0.0285 0.0675)
+(0.0030 -0.0285 0.0675)
+(0.0060 -0.0285 0.0675)
+(-0.0060 -0.0255 0.0675)
+(-0.0030 -0.0255 0.0675)
+(0.0000 -0.0255 0.0675)
+(0.0030 -0.0255 0.0675)
+(0.0060 -0.0255 0.0675)
+(-0.0060 -0.0225 0.0675)
+(-0.0030 -0.0225 0.0675)
+(0.0000 -0.0225 0.0675)
+(0.0030 -0.0225 0.0675)
+(0.0060 -0.0225 0.0675)
+(-0.0060 -0.0195 0.0675)
+(-0.0030 -0.0195 0.0675)
+(0.0000 -0.0195 0.0675)
+(0.0030 -0.0195 0.0675)
+(0.0060 -0.0195 0.0675)
+(-0.0060 -0.0165 0.0675)
+(-0.0030 -0.0165 0.0675)
+(0.0000 -0.0165 0.0675)
+(0.0030 -0.0165 0.0675)
+(0.0060 -0.0165 0.0675)
+(-0.0060 -0.0135 0.0675)
+(-0.0030 -0.0135 0.0675)
+(0.0000 -0.0135 0.0675)
+(0.0030 -0.0135 0.0675)
+(0.0060 -0.0135 0.0675)
+(-0.0060 -0.0105 0.0675)
+(-0.0030 -0.0105 0.0675)
+(0.0000 -0.0105 0.0675)
+(0.0030 -0.0105 0.0675)
+(0.0060 -0.0105 0.0675)
+(-0.0060 -0.0075 0.0675)
+(-0.0030 -0.0075 0.0675)
+(0.0000 -0.0075 0.0675)
+(0.0030 -0.0075 0.0675)
+(0.0060 -0.0075 0.0675)
+(-0.0060 -0.0045 0.0675)
+(-0.0030 -0.0045 0.0675)
+(0.0000 -0.0045 0.0675)
+(0.0030 -0.0045 0.0675)
+(0.0060 -0.0045 0.0675)
+(-0.0060 -0.0015 0.0675)
+(-0.0030 -0.0015 0.0675)
+(0.0000 -0.0015 0.0675)
+(0.0030 -0.0015 0.0675)
+(0.0060 -0.0015 0.0675)
+(-0.0060 0.0015 0.0675)
+(-0.0030 0.0015 0.0675)
+(0.0000 0.0015 0.0675)
+(0.0030 0.0015 0.0675)
+(0.0060 0.0015 0.0675)
+(-0.0060 0.0045 0.0675)
+(-0.0030 0.0045 0.0675)
+(0.0000 0.0045 0.0675)
+(0.0030 0.0045 0.0675)
+(0.0060 0.0045 0.0675)
+(-0.0060 0.0075 0.0675)
+(-0.0030 0.0075 0.0675)
+(0.0000 0.0075 0.0675)
+(0.0030 0.0075 0.0675)
+(0.0060 0.0075 0.0675)
+(-0.0060 0.0105 0.0675)
+(-0.0030 0.0105 0.0675)
+(0.0000 0.0105 0.0675)
+(0.0030 0.0105 0.0675)
+(0.0060 0.0105 0.0675)
+(-0.0060 0.0135 0.0675)
+(-0.0030 0.0135 0.0675)
+(0.0000 0.0135 0.0675)
+(0.0030 0.0135 0.0675)
+(0.0060 0.0135 0.0675)
+(-0.0060 0.0165 0.0675)
+(-0.0030 0.0165 0.0675)
+(0.0000 0.0165 0.0675)
+(0.0030 0.0165 0.0675)
+(0.0060 0.0165 0.0675)
+(-0.0060 0.0195 0.0675)
+(-0.0030 0.0195 0.0675)
+(0.0000 0.0195 0.0675)
+(0.0030 0.0195 0.0675)
+(0.0060 0.0195 0.0675)
+(-0.0060 0.0225 0.0675)
+(-0.0030 0.0225 0.0675)
+(0.0000 0.0225 0.0675)
+(0.0030 0.0225 0.0675)
+(0.0060 0.0225 0.0675)
+(-0.0060 0.0255 0.0675)
+(-0.0030 0.0255 0.0675)
+(0.0000 0.0255 0.0675)
+(0.0030 0.0255 0.0675)
+(0.0060 0.0255 0.0675)
+(-0.0060 0.0285 0.0675)
+(-0.0030 0.0285 0.0675)
+(0.0000 0.0285 0.0675)
+(0.0030 0.0285 0.0675)
+(0.0060 0.0285 0.0675)
+(-0.0060 0.0315 0.0675)
+(-0.0030 0.0315 0.0675)
+(0.0000 0.0315 0.0675)
+(0.0030 0.0315 0.0675)
+(0.0060 0.0315 0.0675)
+(-0.0060 0.0345 0.0675)
+(-0.0030 0.0345 0.0675)
+(0.0000 0.0345 0.0675)
+(0.0030 0.0345 0.0675)
+(0.0060 0.0345 0.0675)
+(-0.0060 0.0375 0.0675)
+(-0.0030 0.0375 0.0675)
+(0.0000 0.0375 0.0675)
+(0.0030 0.0375 0.0675)
+(0.0060 0.0375 0.0675)
+(-0.0060 0.0405 0.0675)
+(-0.0030 0.0405 0.0675)
+(0.0000 0.0405 0.0675)
+(0.0030 0.0405 0.0675)
+(0.0060 0.0405 0.0675)
+(-0.0060 0.0435 0.0675)
+(-0.0030 0.0435 0.0675)
+(0.0000 0.0435 0.0675)
+(0.0030 0.0435 0.0675)
+(0.0060 0.0435 0.0675)
+(-0.0060 0.0465 0.0675)
+(-0.0030 0.0465 0.0675)
+(0.0000 0.0465 0.0675)
+(0.0030 0.0465 0.0675)
+(0.0060 0.0465 0.0675)
+(-0.0060 0.0495 0.0675)
+(-0.0030 0.0495 0.0675)
+(0.0000 0.0495 0.0675)
+(0.0030 0.0495 0.0675)
+(0.0060 0.0495 0.0675)
+(-0.0060 0.0525 0.0675)
+(-0.0030 0.0525 0.0675)
+(0.0000 0.0525 0.0675)
+(0.0030 0.0525 0.0675)
+(0.0060 0.0525 0.0675)
+(-0.0060 0.0555 0.0675)
+(-0.0030 0.0555 0.0675)
+(0.0000 0.0555 0.0675)
+(0.0030 0.0555 0.0675)
+(0.0060 0.0555 0.0675)
+(-0.0060 0.0585 0.0675)
+(-0.0030 0.0585 0.0675)
+(0.0000 0.0585 0.0675)
+(0.0030 0.0585 0.0675)
+(0.0060 0.0585 0.0675)
+(-0.0060 0.0615 0.0675)
+(-0.0030 0.0615 0.0675)
+(0.0000 0.0615 0.0675)
+(0.0030 0.0615 0.0675)
+(0.0060 0.0615 0.0675)
+(-0.0060 0.0645 0.0675)
+(-0.0030 0.0645 0.0675)
+(0.0000 0.0645 0.0675)
+(0.0030 0.0645 0.0675)
+(0.0060 0.0645 0.0675)
+(-0.0060 0.0675 0.0675)
+(-0.0030 0.0675 0.0675)
+(0.0000 0.0675 0.0675)
+(0.0030 0.0675 0.0675)
+(0.0060 0.0675 0.0675)
+(-0.0060 0.0705 0.0675)
+(-0.0030 0.0705 0.0675)
+(0.0000 0.0705 0.0675)
+(0.0030 0.0705 0.0675)
+(0.0060 0.0705 0.0675)
+(-0.0060 0.0735 0.0675)
+(-0.0030 0.0735 0.0675)
+(0.0000 0.0735 0.0675)
+(0.0030 0.0735 0.0675)
+(0.0060 0.0735 0.0675)
+(-0.0060 -0.0735 0.0705)
+(-0.0030 -0.0735 0.0705)
+(0.0000 -0.0735 0.0705)
+(0.0030 -0.0735 0.0705)
+(0.0060 -0.0735 0.0705)
+(-0.0060 -0.0705 0.0705)
+(-0.0030 -0.0705 0.0705)
+(0.0000 -0.0705 0.0705)
+(0.0030 -0.0705 0.0705)
+(0.0060 -0.0705 0.0705)
+(-0.0060 -0.0675 0.0705)
+(-0.0030 -0.0675 0.0705)
+(0.0000 -0.0675 0.0705)
+(0.0030 -0.0675 0.0705)
+(0.0060 -0.0675 0.0705)
+(-0.0060 -0.0645 0.0705)
+(-0.0030 -0.0645 0.0705)
+(0.0000 -0.0645 0.0705)
+(0.0030 -0.0645 0.0705)
+(0.0060 -0.0645 0.0705)
+(-0.0060 -0.0615 0.0705)
+(-0.0030 -0.0615 0.0705)
+(0.0000 -0.0615 0.0705)
+(0.0030 -0.0615 0.0705)
+(0.0060 -0.0615 0.0705)
+(-0.0060 -0.0585 0.0705)
+(-0.0030 -0.0585 0.0705)
+(0.0000 -0.0585 0.0705)
+(0.0030 -0.0585 0.0705)
+(0.0060 -0.0585 0.0705)
+(-0.0060 -0.0555 0.0705)
+(-0.0030 -0.0555 0.0705)
+(0.0000 -0.0555 0.0705)
+(0.0030 -0.0555 0.0705)
+(0.0060 -0.0555 0.0705)
+(-0.0060 -0.0525 0.0705)
+(-0.0030 -0.0525 0.0705)
+(0.0000 -0.0525 0.0705)
+(0.0030 -0.0525 0.0705)
+(0.0060 -0.0525 0.0705)
+(-0.0060 -0.0495 0.0705)
+(-0.0030 -0.0495 0.0705)
+(0.0000 -0.0495 0.0705)
+(0.0030 -0.0495 0.0705)
+(0.0060 -0.0495 0.0705)
+(-0.0060 -0.0465 0.0705)
+(-0.0030 -0.0465 0.0705)
+(0.0000 -0.0465 0.0705)
+(0.0030 -0.0465 0.0705)
+(0.0060 -0.0465 0.0705)
+(-0.0060 -0.0435 0.0705)
+(-0.0030 -0.0435 0.0705)
+(0.0000 -0.0435 0.0705)
+(0.0030 -0.0435 0.0705)
+(0.0060 -0.0435 0.0705)
+(-0.0060 -0.0405 0.0705)
+(-0.0030 -0.0405 0.0705)
+(0.0000 -0.0405 0.0705)
+(0.0030 -0.0405 0.0705)
+(0.0060 -0.0405 0.0705)
+(-0.0060 -0.0375 0.0705)
+(-0.0030 -0.0375 0.0705)
+(0.0000 -0.0375 0.0705)
+(0.0030 -0.0375 0.0705)
+(0.0060 -0.0375 0.0705)
+(-0.0060 -0.0345 0.0705)
+(-0.0030 -0.0345 0.0705)
+(0.0000 -0.0345 0.0705)
+(0.0030 -0.0345 0.0705)
+(0.0060 -0.0345 0.0705)
+(-0.0060 -0.0315 0.0705)
+(-0.0030 -0.0315 0.0705)
+(0.0000 -0.0315 0.0705)
+(0.0030 -0.0315 0.0705)
+(0.0060 -0.0315 0.0705)
+(-0.0060 -0.0285 0.0705)
+(-0.0030 -0.0285 0.0705)
+(0.0000 -0.0285 0.0705)
+(0.0030 -0.0285 0.0705)
+(0.0060 -0.0285 0.0705)
+(-0.0060 -0.0255 0.0705)
+(-0.0030 -0.0255 0.0705)
+(0.0000 -0.0255 0.0705)
+(0.0030 -0.0255 0.0705)
+(0.0060 -0.0255 0.0705)
+(-0.0060 -0.0225 0.0705)
+(-0.0030 -0.0225 0.0705)
+(0.0000 -0.0225 0.0705)
+(0.0030 -0.0225 0.0705)
+(0.0060 -0.0225 0.0705)
+(-0.0060 -0.0195 0.0705)
+(-0.0030 -0.0195 0.0705)
+(0.0000 -0.0195 0.0705)
+(0.0030 -0.0195 0.0705)
+(0.0060 -0.0195 0.0705)
+(-0.0060 -0.0165 0.0705)
+(-0.0030 -0.0165 0.0705)
+(0.0000 -0.0165 0.0705)
+(0.0030 -0.0165 0.0705)
+(0.0060 -0.0165 0.0705)
+(-0.0060 -0.0135 0.0705)
+(-0.0030 -0.0135 0.0705)
+(0.0000 -0.0135 0.0705)
+(0.0030 -0.0135 0.0705)
+(0.0060 -0.0135 0.0705)
+(-0.0060 -0.0105 0.0705)
+(-0.0030 -0.0105 0.0705)
+(0.0000 -0.0105 0.0705)
+(0.0030 -0.0105 0.0705)
+(0.0060 -0.0105 0.0705)
+(-0.0060 -0.0075 0.0705)
+(-0.0030 -0.0075 0.0705)
+(0.0000 -0.0075 0.0705)
+(0.0030 -0.0075 0.0705)
+(0.0060 -0.0075 0.0705)
+(-0.0060 -0.0045 0.0705)
+(-0.0030 -0.0045 0.0705)
+(0.0000 -0.0045 0.0705)
+(0.0030 -0.0045 0.0705)
+(0.0060 -0.0045 0.0705)
+(-0.0060 -0.0015 0.0705)
+(-0.0030 -0.0015 0.0705)
+(0.0000 -0.0015 0.0705)
+(0.0030 -0.0015 0.0705)
+(0.0060 -0.0015 0.0705)
+(-0.0060 0.0015 0.0705)
+(-0.0030 0.0015 0.0705)
+(0.0000 0.0015 0.0705)
+(0.0030 0.0015 0.0705)
+(0.0060 0.0015 0.0705)
+(-0.0060 0.0045 0.0705)
+(-0.0030 0.0045 0.0705)
+(0.0000 0.0045 0.0705)
+(0.0030 0.0045 0.0705)
+(0.0060 0.0045 0.0705)
+(-0.0060 0.0075 0.0705)
+(-0.0030 0.0075 0.0705)
+(0.0000 0.0075 0.0705)
+(0.0030 0.0075 0.0705)
+(0.0060 0.0075 0.0705)
+(-0.0060 0.0105 0.0705)
+(-0.0030 0.0105 0.0705)
+(0.0000 0.0105 0.0705)
+(0.0030 0.0105 0.0705)
+(0.0060 0.0105 0.0705)
+(-0.0060 0.0135 0.0705)
+(-0.0030 0.0135 0.0705)
+(0.0000 0.0135 0.0705)
+(0.0030 0.0135 0.0705)
+(0.0060 0.0135 0.0705)
+(-0.0060 0.0165 0.0705)
+(-0.0030 0.0165 0.0705)
+(0.0000 0.0165 0.0705)
+(0.0030 0.0165 0.0705)
+(0.0060 0.0165 0.0705)
+(-0.0060 0.0195 0.0705)
+(-0.0030 0.0195 0.0705)
+(0.0000 0.0195 0.0705)
+(0.0030 0.0195 0.0705)
+(0.0060 0.0195 0.0705)
+(-0.0060 0.0225 0.0705)
+(-0.0030 0.0225 0.0705)
+(0.0000 0.0225 0.0705)
+(0.0030 0.0225 0.0705)
+(0.0060 0.0225 0.0705)
+(-0.0060 0.0255 0.0705)
+(-0.0030 0.0255 0.0705)
+(0.0000 0.0255 0.0705)
+(0.0030 0.0255 0.0705)
+(0.0060 0.0255 0.0705)
+(-0.0060 0.0285 0.0705)
+(-0.0030 0.0285 0.0705)
+(0.0000 0.0285 0.0705)
+(0.0030 0.0285 0.0705)
+(0.0060 0.0285 0.0705)
+(-0.0060 0.0315 0.0705)
+(-0.0030 0.0315 0.0705)
+(0.0000 0.0315 0.0705)
+(0.0030 0.0315 0.0705)
+(0.0060 0.0315 0.0705)
+(-0.0060 0.0345 0.0705)
+(-0.0030 0.0345 0.0705)
+(0.0000 0.0345 0.0705)
+(0.0030 0.0345 0.0705)
+(0.0060 0.0345 0.0705)
+(-0.0060 0.0375 0.0705)
+(-0.0030 0.0375 0.0705)
+(0.0000 0.0375 0.0705)
+(0.0030 0.0375 0.0705)
+(0.0060 0.0375 0.0705)
+(-0.0060 0.0405 0.0705)
+(-0.0030 0.0405 0.0705)
+(0.0000 0.0405 0.0705)
+(0.0030 0.0405 0.0705)
+(0.0060 0.0405 0.0705)
+(-0.0060 0.0435 0.0705)
+(-0.0030 0.0435 0.0705)
+(0.0000 0.0435 0.0705)
+(0.0030 0.0435 0.0705)
+(0.0060 0.0435 0.0705)
+(-0.0060 0.0465 0.0705)
+(-0.0030 0.0465 0.0705)
+(0.0000 0.0465 0.0705)
+(0.0030 0.0465 0.0705)
+(0.0060 0.0465 0.0705)
+(-0.0060 0.0495 0.0705)
+(-0.0030 0.0495 0.0705)
+(0.0000 0.0495 0.0705)
+(0.0030 0.0495 0.0705)
+(0.0060 0.0495 0.0705)
+(-0.0060 0.0525 0.0705)
+(-0.0030 0.0525 0.0705)
+(0.0000 0.0525 0.0705)
+(0.0030 0.0525 0.0705)
+(0.0060 0.0525 0.0705)
+(-0.0060 0.0555 0.0705)
+(-0.0030 0.0555 0.0705)
+(0.0000 0.0555 0.0705)
+(0.0030 0.0555 0.0705)
+(0.0060 0.0555 0.0705)
+(-0.0060 0.0585 0.0705)
+(-0.0030 0.0585 0.0705)
+(0.0000 0.0585 0.0705)
+(0.0030 0.0585 0.0705)
+(0.0060 0.0585 0.0705)
+(-0.0060 0.0615 0.0705)
+(-0.0030 0.0615 0.0705)
+(0.0000 0.0615 0.0705)
+(0.0030 0.0615 0.0705)
+(0.0060 0.0615 0.0705)
+(-0.0060 0.0645 0.0705)
+(-0.0030 0.0645 0.0705)
+(0.0000 0.0645 0.0705)
+(0.0030 0.0645 0.0705)
+(0.0060 0.0645 0.0705)
+(-0.0060 0.0675 0.0705)
+(-0.0030 0.0675 0.0705)
+(0.0000 0.0675 0.0705)
+(0.0030 0.0675 0.0705)
+(0.0060 0.0675 0.0705)
+(-0.0060 0.0705 0.0705)
+(-0.0030 0.0705 0.0705)
+(0.0000 0.0705 0.0705)
+(0.0030 0.0705 0.0705)
+(0.0060 0.0705 0.0705)
+(-0.0060 0.0735 0.0705)
+(-0.0030 0.0735 0.0705)
+(0.0000 0.0735 0.0705)
+(0.0030 0.0735 0.0705)
+(0.0060 0.0735 0.0705)
+(-0.0060 -0.0735 0.0735)
+(-0.0030 -0.0735 0.0735)
+(0.0000 -0.0735 0.0735)
+(0.0030 -0.0735 0.0735)
+(0.0060 -0.0735 0.0735)
+(-0.0060 -0.0705 0.0735)
+(-0.0030 -0.0705 0.0735)
+(0.0000 -0.0705 0.0735)
+(0.0030 -0.0705 0.0735)
+(0.0060 -0.0705 0.0735)
+(-0.0060 -0.0675 0.0735)
+(-0.0030 -0.0675 0.0735)
+(0.0000 -0.0675 0.0735)
+(0.0030 -0.0675 0.0735)
+(0.0060 -0.0675 0.0735)
+(-0.0060 -0.0645 0.0735)
+(-0.0030 -0.0645 0.0735)
+(0.0000 -0.0645 0.0735)
+(0.0030 -0.0645 0.0735)
+(0.0060 -0.0645 0.0735)
+(-0.0060 -0.0615 0.0735)
+(-0.0030 -0.0615 0.0735)
+(0.0000 -0.0615 0.0735)
+(0.0030 -0.0615 0.0735)
+(0.0060 -0.0615 0.0735)
+(-0.0060 -0.0585 0.0735)
+(-0.0030 -0.0585 0.0735)
+(0.0000 -0.0585 0.0735)
+(0.0030 -0.0585 0.0735)
+(0.0060 -0.0585 0.0735)
+(-0.0060 -0.0555 0.0735)
+(-0.0030 -0.0555 0.0735)
+(0.0000 -0.0555 0.0735)
+(0.0030 -0.0555 0.0735)
+(0.0060 -0.0555 0.0735)
+(-0.0060 -0.0525 0.0735)
+(-0.0030 -0.0525 0.0735)
+(0.0000 -0.0525 0.0735)
+(0.0030 -0.0525 0.0735)
+(0.0060 -0.0525 0.0735)
+(-0.0060 -0.0495 0.0735)
+(-0.0030 -0.0495 0.0735)
+(0.0000 -0.0495 0.0735)
+(0.0030 -0.0495 0.0735)
+(0.0060 -0.0495 0.0735)
+(-0.0060 -0.0465 0.0735)
+(-0.0030 -0.0465 0.0735)
+(0.0000 -0.0465 0.0735)
+(0.0030 -0.0465 0.0735)
+(0.0060 -0.0465 0.0735)
+(-0.0060 -0.0435 0.0735)
+(-0.0030 -0.0435 0.0735)
+(0.0000 -0.0435 0.0735)
+(0.0030 -0.0435 0.0735)
+(0.0060 -0.0435 0.0735)
+(-0.0060 -0.0405 0.0735)
+(-0.0030 -0.0405 0.0735)
+(0.0000 -0.0405 0.0735)
+(0.0030 -0.0405 0.0735)
+(0.0060 -0.0405 0.0735)
+(-0.0060 -0.0375 0.0735)
+(-0.0030 -0.0375 0.0735)
+(0.0000 -0.0375 0.0735)
+(0.0030 -0.0375 0.0735)
+(0.0060 -0.0375 0.0735)
+(-0.0060 -0.0345 0.0735)
+(-0.0030 -0.0345 0.0735)
+(0.0000 -0.0345 0.0735)
+(0.0030 -0.0345 0.0735)
+(0.0060 -0.0345 0.0735)
+(-0.0060 -0.0315 0.0735)
+(-0.0030 -0.0315 0.0735)
+(0.0000 -0.0315 0.0735)
+(0.0030 -0.0315 0.0735)
+(0.0060 -0.0315 0.0735)
+(-0.0060 -0.0285 0.0735)
+(-0.0030 -0.0285 0.0735)
+(0.0000 -0.0285 0.0735)
+(0.0030 -0.0285 0.0735)
+(0.0060 -0.0285 0.0735)
+(-0.0060 -0.0255 0.0735)
+(-0.0030 -0.0255 0.0735)
+(0.0000 -0.0255 0.0735)
+(0.0030 -0.0255 0.0735)
+(0.0060 -0.0255 0.0735)
+(-0.0060 -0.0225 0.0735)
+(-0.0030 -0.0225 0.0735)
+(0.0000 -0.0225 0.0735)
+(0.0030 -0.0225 0.0735)
+(0.0060 -0.0225 0.0735)
+(-0.0060 -0.0195 0.0735)
+(-0.0030 -0.0195 0.0735)
+(0.0000 -0.0195 0.0735)
+(0.0030 -0.0195 0.0735)
+(0.0060 -0.0195 0.0735)
+(-0.0060 -0.0165 0.0735)
+(-0.0030 -0.0165 0.0735)
+(0.0000 -0.0165 0.0735)
+(0.0030 -0.0165 0.0735)
+(0.0060 -0.0165 0.0735)
+(-0.0060 -0.0135 0.0735)
+(-0.0030 -0.0135 0.0735)
+(0.0000 -0.0135 0.0735)
+(0.0030 -0.0135 0.0735)
+(0.0060 -0.0135 0.0735)
+(-0.0060 -0.0105 0.0735)
+(-0.0030 -0.0105 0.0735)
+(0.0000 -0.0105 0.0735)
+(0.0030 -0.0105 0.0735)
+(0.0060 -0.0105 0.0735)
+(-0.0060 -0.0075 0.0735)
+(-0.0030 -0.0075 0.0735)
+(0.0000 -0.0075 0.0735)
+(0.0030 -0.0075 0.0735)
+(0.0060 -0.0075 0.0735)
+(-0.0060 -0.0045 0.0735)
+(-0.0030 -0.0045 0.0735)
+(0.0000 -0.0045 0.0735)
+(0.0030 -0.0045 0.0735)
+(0.0060 -0.0045 0.0735)
+(-0.0060 -0.0015 0.0735)
+(-0.0030 -0.0015 0.0735)
+(0.0000 -0.0015 0.0735)
+(0.0030 -0.0015 0.0735)
+(0.0060 -0.0015 0.0735)
+(-0.0060 0.0015 0.0735)
+(-0.0030 0.0015 0.0735)
+(0.0000 0.0015 0.0735)
+(0.0030 0.0015 0.0735)
+(0.0060 0.0015 0.0735)
+(-0.0060 0.0045 0.0735)
+(-0.0030 0.0045 0.0735)
+(0.0000 0.0045 0.0735)
+(0.0030 0.0045 0.0735)
+(0.0060 0.0045 0.0735)
+(-0.0060 0.0075 0.0735)
+(-0.0030 0.0075 0.0735)
+(0.0000 0.0075 0.0735)
+(0.0030 0.0075 0.0735)
+(0.0060 0.0075 0.0735)
+(-0.0060 0.0105 0.0735)
+(-0.0030 0.0105 0.0735)
+(0.0000 0.0105 0.0735)
+(0.0030 0.0105 0.0735)
+(0.0060 0.0105 0.0735)
+(-0.0060 0.0135 0.0735)
+(-0.0030 0.0135 0.0735)
+(0.0000 0.0135 0.0735)
+(0.0030 0.0135 0.0735)
+(0.0060 0.0135 0.0735)
+(-0.0060 0.0165 0.0735)
+(-0.0030 0.0165 0.0735)
+(0.0000 0.0165 0.0735)
+(0.0030 0.0165 0.0735)
+(0.0060 0.0165 0.0735)
+(-0.0060 0.0195 0.0735)
+(-0.0030 0.0195 0.0735)
+(0.0000 0.0195 0.0735)
+(0.0030 0.0195 0.0735)
+(0.0060 0.0195 0.0735)
+(-0.0060 0.0225 0.0735)
+(-0.0030 0.0225 0.0735)
+(0.0000 0.0225 0.0735)
+(0.0030 0.0225 0.0735)
+(0.0060 0.0225 0.0735)
+(-0.0060 0.0255 0.0735)
+(-0.0030 0.0255 0.0735)
+(0.0000 0.0255 0.0735)
+(0.0030 0.0255 0.0735)
+(0.0060 0.0255 0.0735)
+(-0.0060 0.0285 0.0735)
+(-0.0030 0.0285 0.0735)
+(0.0000 0.0285 0.0735)
+(0.0030 0.0285 0.0735)
+(0.0060 0.0285 0.0735)
+(-0.0060 0.0315 0.0735)
+(-0.0030 0.0315 0.0735)
+(0.0000 0.0315 0.0735)
+(0.0030 0.0315 0.0735)
+(0.0060 0.0315 0.0735)
+(-0.0060 0.0345 0.0735)
+(-0.0030 0.0345 0.0735)
+(0.0000 0.0345 0.0735)
+(0.0030 0.0345 0.0735)
+(0.0060 0.0345 0.0735)
+(-0.0060 0.0375 0.0735)
+(-0.0030 0.0375 0.0735)
+(0.0000 0.0375 0.0735)
+(0.0030 0.0375 0.0735)
+(0.0060 0.0375 0.0735)
+(-0.0060 0.0405 0.0735)
+(-0.0030 0.0405 0.0735)
+(0.0000 0.0405 0.0735)
+(0.0030 0.0405 0.0735)
+(0.0060 0.0405 0.0735)
+(-0.0060 0.0435 0.0735)
+(-0.0030 0.0435 0.0735)
+(0.0000 0.0435 0.0735)
+(0.0030 0.0435 0.0735)
+(0.0060 0.0435 0.0735)
+(-0.0060 0.0465 0.0735)
+(-0.0030 0.0465 0.0735)
+(0.0000 0.0465 0.0735)
+(0.0030 0.0465 0.0735)
+(0.0060 0.0465 0.0735)
+(-0.0060 0.0495 0.0735)
+(-0.0030 0.0495 0.0735)
+(0.0000 0.0495 0.0735)
+(0.0030 0.0495 0.0735)
+(0.0060 0.0495 0.0735)
+(-0.0060 0.0525 0.0735)
+(-0.0030 0.0525 0.0735)
+(0.0000 0.0525 0.0735)
+(0.0030 0.0525 0.0735)
+(0.0060 0.0525 0.0735)
+(-0.0060 0.0555 0.0735)
+(-0.0030 0.0555 0.0735)
+(0.0000 0.0555 0.0735)
+(0.0030 0.0555 0.0735)
+(0.0060 0.0555 0.0735)
+(-0.0060 0.0585 0.0735)
+(-0.0030 0.0585 0.0735)
+(0.0000 0.0585 0.0735)
+(0.0030 0.0585 0.0735)
+(0.0060 0.0585 0.0735)
+(-0.0060 0.0615 0.0735)
+(-0.0030 0.0615 0.0735)
+(0.0000 0.0615 0.0735)
+(0.0030 0.0615 0.0735)
+(0.0060 0.0615 0.0735)
+(-0.0060 0.0645 0.0735)
+(-0.0030 0.0645 0.0735)
+(0.0000 0.0645 0.0735)
+(0.0030 0.0645 0.0735)
+(0.0060 0.0645 0.0735)
+(-0.0060 0.0675 0.0735)
+(-0.0030 0.0675 0.0735)
+(0.0000 0.0675 0.0735)
+(0.0030 0.0675 0.0735)
+(0.0060 0.0675 0.0735)
+(-0.0060 0.0705 0.0735)
+(-0.0030 0.0705 0.0735)
+(0.0000 0.0705 0.0735)
+(0.0030 0.0705 0.0735)
+(0.0060 0.0705 0.0735)
+(-0.0060 0.0735 0.0735)
+(-0.0030 0.0735 0.0735)
+(0.0000 0.0735 0.0735)
+(0.0030 0.0735 0.0735)
+(0.0060 0.0735 0.0735)
+(-0.0060 -0.0735 0.0765)
+(-0.0030 -0.0735 0.0765)
+(0.0000 -0.0735 0.0765)
+(0.0030 -0.0735 0.0765)
+(0.0060 -0.0735 0.0765)
+(-0.0060 -0.0705 0.0765)
+(-0.0030 -0.0705 0.0765)
+(0.0000 -0.0705 0.0765)
+(0.0030 -0.0705 0.0765)
+(0.0060 -0.0705 0.0765)
+(-0.0060 -0.0675 0.0765)
+(-0.0030 -0.0675 0.0765)
+(0.0000 -0.0675 0.0765)
+(0.0030 -0.0675 0.0765)
+(0.0060 -0.0675 0.0765)
+(-0.0060 -0.0645 0.0765)
+(-0.0030 -0.0645 0.0765)
+(0.0000 -0.0645 0.0765)
+(0.0030 -0.0645 0.0765)
+(0.0060 -0.0645 0.0765)
+(-0.0060 -0.0615 0.0765)
+(-0.0030 -0.0615 0.0765)
+(0.0000 -0.0615 0.0765)
+(0.0030 -0.0615 0.0765)
+(0.0060 -0.0615 0.0765)
+(-0.0060 -0.0585 0.0765)
+(-0.0030 -0.0585 0.0765)
+(0.0000 -0.0585 0.0765)
+(0.0030 -0.0585 0.0765)
+(0.0060 -0.0585 0.0765)
+(-0.0060 -0.0555 0.0765)
+(-0.0030 -0.0555 0.0765)
+(0.0000 -0.0555 0.0765)
+(0.0030 -0.0555 0.0765)
+(0.0060 -0.0555 0.0765)
+(-0.0060 -0.0525 0.0765)
+(-0.0030 -0.0525 0.0765)
+(0.0000 -0.0525 0.0765)
+(0.0030 -0.0525 0.0765)
+(0.0060 -0.0525 0.0765)
+(-0.0060 -0.0495 0.0765)
+(-0.0030 -0.0495 0.0765)
+(0.0000 -0.0495 0.0765)
+(0.0030 -0.0495 0.0765)
+(0.0060 -0.0495 0.0765)
+(-0.0060 -0.0465 0.0765)
+(-0.0030 -0.0465 0.0765)
+(0.0000 -0.0465 0.0765)
+(0.0030 -0.0465 0.0765)
+(0.0060 -0.0465 0.0765)
+(-0.0060 -0.0435 0.0765)
+(-0.0030 -0.0435 0.0765)
+(0.0000 -0.0435 0.0765)
+(0.0030 -0.0435 0.0765)
+(0.0060 -0.0435 0.0765)
+(-0.0060 -0.0405 0.0765)
+(-0.0030 -0.0405 0.0765)
+(0.0000 -0.0405 0.0765)
+(0.0030 -0.0405 0.0765)
+(0.0060 -0.0405 0.0765)
+(-0.0060 -0.0375 0.0765)
+(-0.0030 -0.0375 0.0765)
+(0.0000 -0.0375 0.0765)
+(0.0030 -0.0375 0.0765)
+(0.0060 -0.0375 0.0765)
+(-0.0060 -0.0345 0.0765)
+(-0.0030 -0.0345 0.0765)
+(0.0000 -0.0345 0.0765)
+(0.0030 -0.0345 0.0765)
+(0.0060 -0.0345 0.0765)
+(-0.0060 -0.0315 0.0765)
+(-0.0030 -0.0315 0.0765)
+(0.0000 -0.0315 0.0765)
+(0.0030 -0.0315 0.0765)
+(0.0060 -0.0315 0.0765)
+(-0.0060 -0.0285 0.0765)
+(-0.0030 -0.0285 0.0765)
+(0.0000 -0.0285 0.0765)
+(0.0030 -0.0285 0.0765)
+(0.0060 -0.0285 0.0765)
+(-0.0060 -0.0255 0.0765)
+(-0.0030 -0.0255 0.0765)
+(0.0000 -0.0255 0.0765)
+(0.0030 -0.0255 0.0765)
+(0.0060 -0.0255 0.0765)
+(-0.0060 -0.0225 0.0765)
+(-0.0030 -0.0225 0.0765)
+(0.0000 -0.0225 0.0765)
+(0.0030 -0.0225 0.0765)
+(0.0060 -0.0225 0.0765)
+(-0.0060 -0.0195 0.0765)
+(-0.0030 -0.0195 0.0765)
+(0.0000 -0.0195 0.0765)
+(0.0030 -0.0195 0.0765)
+(0.0060 -0.0195 0.0765)
+(-0.0060 -0.0165 0.0765)
+(-0.0030 -0.0165 0.0765)
+(0.0000 -0.0165 0.0765)
+(0.0030 -0.0165 0.0765)
+(0.0060 -0.0165 0.0765)
+(-0.0060 -0.0135 0.0765)
+(-0.0030 -0.0135 0.0765)
+(0.0000 -0.0135 0.0765)
+(0.0030 -0.0135 0.0765)
+(0.0060 -0.0135 0.0765)
+(-0.0060 -0.0105 0.0765)
+(-0.0030 -0.0105 0.0765)
+(0.0000 -0.0105 0.0765)
+(0.0030 -0.0105 0.0765)
+(0.0060 -0.0105 0.0765)
+(-0.0060 -0.0075 0.0765)
+(-0.0030 -0.0075 0.0765)
+(0.0000 -0.0075 0.0765)
+(0.0030 -0.0075 0.0765)
+(0.0060 -0.0075 0.0765)
+(-0.0060 -0.0045 0.0765)
+(-0.0030 -0.0045 0.0765)
+(0.0000 -0.0045 0.0765)
+(0.0030 -0.0045 0.0765)
+(0.0060 -0.0045 0.0765)
+(-0.0060 -0.0015 0.0765)
+(-0.0030 -0.0015 0.0765)
+(0.0000 -0.0015 0.0765)
+(0.0030 -0.0015 0.0765)
+(0.0060 -0.0015 0.0765)
+(-0.0060 0.0015 0.0765)
+(-0.0030 0.0015 0.0765)
+(0.0000 0.0015 0.0765)
+(0.0030 0.0015 0.0765)
+(0.0060 0.0015 0.0765)
+(-0.0060 0.0045 0.0765)
+(-0.0030 0.0045 0.0765)
+(0.0000 0.0045 0.0765)
+(0.0030 0.0045 0.0765)
+(0.0060 0.0045 0.0765)
+(-0.0060 0.0075 0.0765)
+(-0.0030 0.0075 0.0765)
+(0.0000 0.0075 0.0765)
+(0.0030 0.0075 0.0765)
+(0.0060 0.0075 0.0765)
+(-0.0060 0.0105 0.0765)
+(-0.0030 0.0105 0.0765)
+(0.0000 0.0105 0.0765)
+(0.0030 0.0105 0.0765)
+(0.0060 0.0105 0.0765)
+(-0.0060 0.0135 0.0765)
+(-0.0030 0.0135 0.0765)
+(0.0000 0.0135 0.0765)
+(0.0030 0.0135 0.0765)
+(0.0060 0.0135 0.0765)
+(-0.0060 0.0165 0.0765)
+(-0.0030 0.0165 0.0765)
+(0.0000 0.0165 0.0765)
+(0.0030 0.0165 0.0765)
+(0.0060 0.0165 0.0765)
+(-0.0060 0.0195 0.0765)
+(-0.0030 0.0195 0.0765)
+(0.0000 0.0195 0.0765)
+(0.0030 0.0195 0.0765)
+(0.0060 0.0195 0.0765)
+(-0.0060 0.0225 0.0765)
+(-0.0030 0.0225 0.0765)
+(0.0000 0.0225 0.0765)
+(0.0030 0.0225 0.0765)
+(0.0060 0.0225 0.0765)
+(-0.0060 0.0255 0.0765)
+(-0.0030 0.0255 0.0765)
+(0.0000 0.0255 0.0765)
+(0.0030 0.0255 0.0765)
+(0.0060 0.0255 0.0765)
+(-0.0060 0.0285 0.0765)
+(-0.0030 0.0285 0.0765)
+(0.0000 0.0285 0.0765)
+(0.0030 0.0285 0.0765)
+(0.0060 0.0285 0.0765)
+(-0.0060 0.0315 0.0765)
+(-0.0030 0.0315 0.0765)
+(0.0000 0.0315 0.0765)
+(0.0030 0.0315 0.0765)
+(0.0060 0.0315 0.0765)
+(-0.0060 0.0345 0.0765)
+(-0.0030 0.0345 0.0765)
+(0.0000 0.0345 0.0765)
+(0.0030 0.0345 0.0765)
+(0.0060 0.0345 0.0765)
+(-0.0060 0.0375 0.0765)
+(-0.0030 0.0375 0.0765)
+(0.0000 0.0375 0.0765)
+(0.0030 0.0375 0.0765)
+(0.0060 0.0375 0.0765)
+(-0.0060 0.0405 0.0765)
+(-0.0030 0.0405 0.0765)
+(0.0000 0.0405 0.0765)
+(0.0030 0.0405 0.0765)
+(0.0060 0.0405 0.0765)
+(-0.0060 0.0435 0.0765)
+(-0.0030 0.0435 0.0765)
+(0.0000 0.0435 0.0765)
+(0.0030 0.0435 0.0765)
+(0.0060 0.0435 0.0765)
+(-0.0060 0.0465 0.0765)
+(-0.0030 0.0465 0.0765)
+(0.0000 0.0465 0.0765)
+(0.0030 0.0465 0.0765)
+(0.0060 0.0465 0.0765)
+(-0.0060 0.0495 0.0765)
+(-0.0030 0.0495 0.0765)
+(0.0000 0.0495 0.0765)
+(0.0030 0.0495 0.0765)
+(0.0060 0.0495 0.0765)
+(-0.0060 0.0525 0.0765)
+(-0.0030 0.0525 0.0765)
+(0.0000 0.0525 0.0765)
+(0.0030 0.0525 0.0765)
+(0.0060 0.0525 0.0765)
+(-0.0060 0.0555 0.0765)
+(-0.0030 0.0555 0.0765)
+(0.0000 0.0555 0.0765)
+(0.0030 0.0555 0.0765)
+(0.0060 0.0555 0.0765)
+(-0.0060 0.0585 0.0765)
+(-0.0030 0.0585 0.0765)
+(0.0000 0.0585 0.0765)
+(0.0030 0.0585 0.0765)
+(0.0060 0.0585 0.0765)
+(-0.0060 0.0615 0.0765)
+(-0.0030 0.0615 0.0765)
+(0.0000 0.0615 0.0765)
+(0.0030 0.0615 0.0765)
+(0.0060 0.0615 0.0765)
+(-0.0060 0.0645 0.0765)
+(-0.0030 0.0645 0.0765)
+(0.0000 0.0645 0.0765)
+(0.0030 0.0645 0.0765)
+(0.0060 0.0645 0.0765)
+(-0.0060 0.0675 0.0765)
+(-0.0030 0.0675 0.0765)
+(0.0000 0.0675 0.0765)
+(0.0030 0.0675 0.0765)
+(0.0060 0.0675 0.0765)
+(-0.0060 0.0705 0.0765)
+(-0.0030 0.0705 0.0765)
+(0.0000 0.0705 0.0765)
+(0.0030 0.0705 0.0765)
+(0.0060 0.0705 0.0765)
+(-0.0060 0.0735 0.0765)
+(-0.0030 0.0735 0.0765)
+(0.0000 0.0735 0.0765)
+(0.0030 0.0735 0.0765)
+(0.0060 0.0735 0.0765)
+(-0.0060 -0.0735 0.0795)
+(-0.0030 -0.0735 0.0795)
+(0.0000 -0.0735 0.0795)
+(0.0030 -0.0735 0.0795)
+(0.0060 -0.0735 0.0795)
+(-0.0060 -0.0705 0.0795)
+(-0.0030 -0.0705 0.0795)
+(0.0000 -0.0705 0.0795)
+(0.0030 -0.0705 0.0795)
+(0.0060 -0.0705 0.0795)
+(-0.0060 -0.0675 0.0795)
+(-0.0030 -0.0675 0.0795)
+(0.0000 -0.0675 0.0795)
+(0.0030 -0.0675 0.0795)
+(0.0060 -0.0675 0.0795)
+(-0.0060 -0.0645 0.0795)
+(-0.0030 -0.0645 0.0795)
+(0.0000 -0.0645 0.0795)
+(0.0030 -0.0645 0.0795)
+(0.0060 -0.0645 0.0795)
+(-0.0060 -0.0615 0.0795)
+(-0.0030 -0.0615 0.0795)
+(0.0000 -0.0615 0.0795)
+(0.0030 -0.0615 0.0795)
+(0.0060 -0.0615 0.0795)
+(-0.0060 -0.0585 0.0795)
+(-0.0030 -0.0585 0.0795)
+(0.0000 -0.0585 0.0795)
+(0.0030 -0.0585 0.0795)
+(0.0060 -0.0585 0.0795)
+(-0.0060 -0.0555 0.0795)
+(-0.0030 -0.0555 0.0795)
+(0.0000 -0.0555 0.0795)
+(0.0030 -0.0555 0.0795)
+(0.0060 -0.0555 0.0795)
+(-0.0060 -0.0525 0.0795)
+(-0.0030 -0.0525 0.0795)
+(0.0000 -0.0525 0.0795)
+(0.0030 -0.0525 0.0795)
+(0.0060 -0.0525 0.0795)
+(-0.0060 -0.0495 0.0795)
+(-0.0030 -0.0495 0.0795)
+(0.0000 -0.0495 0.0795)
+(0.0030 -0.0495 0.0795)
+(0.0060 -0.0495 0.0795)
+(-0.0060 -0.0465 0.0795)
+(-0.0030 -0.0465 0.0795)
+(0.0000 -0.0465 0.0795)
+(0.0030 -0.0465 0.0795)
+(0.0060 -0.0465 0.0795)
+(-0.0060 -0.0435 0.0795)
+(-0.0030 -0.0435 0.0795)
+(0.0000 -0.0435 0.0795)
+(0.0030 -0.0435 0.0795)
+(0.0060 -0.0435 0.0795)
+(-0.0060 -0.0405 0.0795)
+(-0.0030 -0.0405 0.0795)
+(0.0000 -0.0405 0.0795)
+(0.0030 -0.0405 0.0795)
+(0.0060 -0.0405 0.0795)
+(-0.0060 -0.0375 0.0795)
+(-0.0030 -0.0375 0.0795)
+(0.0000 -0.0375 0.0795)
+(0.0030 -0.0375 0.0795)
+(0.0060 -0.0375 0.0795)
+(-0.0060 -0.0345 0.0795)
+(-0.0030 -0.0345 0.0795)
+(0.0000 -0.0345 0.0795)
+(0.0030 -0.0345 0.0795)
+(0.0060 -0.0345 0.0795)
+(-0.0060 -0.0315 0.0795)
+(-0.0030 -0.0315 0.0795)
+(0.0000 -0.0315 0.0795)
+(0.0030 -0.0315 0.0795)
+(0.0060 -0.0315 0.0795)
+(-0.0060 -0.0285 0.0795)
+(-0.0030 -0.0285 0.0795)
+(0.0000 -0.0285 0.0795)
+(0.0030 -0.0285 0.0795)
+(0.0060 -0.0285 0.0795)
+(-0.0060 -0.0255 0.0795)
+(-0.0030 -0.0255 0.0795)
+(0.0000 -0.0255 0.0795)
+(0.0030 -0.0255 0.0795)
+(0.0060 -0.0255 0.0795)
+(-0.0060 -0.0225 0.0795)
+(-0.0030 -0.0225 0.0795)
+(0.0000 -0.0225 0.0795)
+(0.0030 -0.0225 0.0795)
+(0.0060 -0.0225 0.0795)
+(-0.0060 -0.0195 0.0795)
+(-0.0030 -0.0195 0.0795)
+(0.0000 -0.0195 0.0795)
+(0.0030 -0.0195 0.0795)
+(0.0060 -0.0195 0.0795)
+(-0.0060 -0.0165 0.0795)
+(-0.0030 -0.0165 0.0795)
+(0.0000 -0.0165 0.0795)
+(0.0030 -0.0165 0.0795)
+(0.0060 -0.0165 0.0795)
+(-0.0060 -0.0135 0.0795)
+(-0.0030 -0.0135 0.0795)
+(0.0000 -0.0135 0.0795)
+(0.0030 -0.0135 0.0795)
+(0.0060 -0.0135 0.0795)
+(-0.0060 -0.0105 0.0795)
+(-0.0030 -0.0105 0.0795)
+(0.0000 -0.0105 0.0795)
+(0.0030 -0.0105 0.0795)
+(0.0060 -0.0105 0.0795)
+(-0.0060 -0.0075 0.0795)
+(-0.0030 -0.0075 0.0795)
+(0.0000 -0.0075 0.0795)
+(0.0030 -0.0075 0.0795)
+(0.0060 -0.0075 0.0795)
+(-0.0060 -0.0045 0.0795)
+(-0.0030 -0.0045 0.0795)
+(0.0000 -0.0045 0.0795)
+(0.0030 -0.0045 0.0795)
+(0.0060 -0.0045 0.0795)
+(-0.0060 -0.0015 0.0795)
+(-0.0030 -0.0015 0.0795)
+(0.0000 -0.0015 0.0795)
+(0.0030 -0.0015 0.0795)
+(0.0060 -0.0015 0.0795)
+(-0.0060 0.0015 0.0795)
+(-0.0030 0.0015 0.0795)
+(0.0000 0.0015 0.0795)
+(0.0030 0.0015 0.0795)
+(0.0060 0.0015 0.0795)
+(-0.0060 0.0045 0.0795)
+(-0.0030 0.0045 0.0795)
+(0.0000 0.0045 0.0795)
+(0.0030 0.0045 0.0795)
+(0.0060 0.0045 0.0795)
+(-0.0060 0.0075 0.0795)
+(-0.0030 0.0075 0.0795)
+(0.0000 0.0075 0.0795)
+(0.0030 0.0075 0.0795)
+(0.0060 0.0075 0.0795)
+(-0.0060 0.0105 0.0795)
+(-0.0030 0.0105 0.0795)
+(0.0000 0.0105 0.0795)
+(0.0030 0.0105 0.0795)
+(0.0060 0.0105 0.0795)
+(-0.0060 0.0135 0.0795)
+(-0.0030 0.0135 0.0795)
+(0.0000 0.0135 0.0795)
+(0.0030 0.0135 0.0795)
+(0.0060 0.0135 0.0795)
+(-0.0060 0.0165 0.0795)
+(-0.0030 0.0165 0.0795)
+(0.0000 0.0165 0.0795)
+(0.0030 0.0165 0.0795)
+(0.0060 0.0165 0.0795)
+(-0.0060 0.0195 0.0795)
+(-0.0030 0.0195 0.0795)
+(0.0000 0.0195 0.0795)
+(0.0030 0.0195 0.0795)
+(0.0060 0.0195 0.0795)
+(-0.0060 0.0225 0.0795)
+(-0.0030 0.0225 0.0795)
+(0.0000 0.0225 0.0795)
+(0.0030 0.0225 0.0795)
+(0.0060 0.0225 0.0795)
+(-0.0060 0.0255 0.0795)
+(-0.0030 0.0255 0.0795)
+(0.0000 0.0255 0.0795)
+(0.0030 0.0255 0.0795)
+(0.0060 0.0255 0.0795)
+(-0.0060 0.0285 0.0795)
+(-0.0030 0.0285 0.0795)
+(0.0000 0.0285 0.0795)
+(0.0030 0.0285 0.0795)
+(0.0060 0.0285 0.0795)
+(-0.0060 0.0315 0.0795)
+(-0.0030 0.0315 0.0795)
+(0.0000 0.0315 0.0795)
+(0.0030 0.0315 0.0795)
+(0.0060 0.0315 0.0795)
+(-0.0060 0.0345 0.0795)
+(-0.0030 0.0345 0.0795)
+(0.0000 0.0345 0.0795)
+(0.0030 0.0345 0.0795)
+(0.0060 0.0345 0.0795)
+(-0.0060 0.0375 0.0795)
+(-0.0030 0.0375 0.0795)
+(0.0000 0.0375 0.0795)
+(0.0030 0.0375 0.0795)
+(0.0060 0.0375 0.0795)
+(-0.0060 0.0405 0.0795)
+(-0.0030 0.0405 0.0795)
+(0.0000 0.0405 0.0795)
+(0.0030 0.0405 0.0795)
+(0.0060 0.0405 0.0795)
+(-0.0060 0.0435 0.0795)
+(-0.0030 0.0435 0.0795)
+(0.0000 0.0435 0.0795)
+(0.0030 0.0435 0.0795)
+(0.0060 0.0435 0.0795)
+(-0.0060 0.0465 0.0795)
+(-0.0030 0.0465 0.0795)
+(0.0000 0.0465 0.0795)
+(0.0030 0.0465 0.0795)
+(0.0060 0.0465 0.0795)
+(-0.0060 0.0495 0.0795)
+(-0.0030 0.0495 0.0795)
+(0.0000 0.0495 0.0795)
+(0.0030 0.0495 0.0795)
+(0.0060 0.0495 0.0795)
+(-0.0060 0.0525 0.0795)
+(-0.0030 0.0525 0.0795)
+(0.0000 0.0525 0.0795)
+(0.0030 0.0525 0.0795)
+(0.0060 0.0525 0.0795)
+(-0.0060 0.0555 0.0795)
+(-0.0030 0.0555 0.0795)
+(0.0000 0.0555 0.0795)
+(0.0030 0.0555 0.0795)
+(0.0060 0.0555 0.0795)
+(-0.0060 0.0585 0.0795)
+(-0.0030 0.0585 0.0795)
+(0.0000 0.0585 0.0795)
+(0.0030 0.0585 0.0795)
+(0.0060 0.0585 0.0795)
+(-0.0060 0.0615 0.0795)
+(-0.0030 0.0615 0.0795)
+(0.0000 0.0615 0.0795)
+(0.0030 0.0615 0.0795)
+(0.0060 0.0615 0.0795)
+(-0.0060 0.0645 0.0795)
+(-0.0030 0.0645 0.0795)
+(0.0000 0.0645 0.0795)
+(0.0030 0.0645 0.0795)
+(0.0060 0.0645 0.0795)
+(-0.0060 0.0675 0.0795)
+(-0.0030 0.0675 0.0795)
+(0.0000 0.0675 0.0795)
+(0.0030 0.0675 0.0795)
+(0.0060 0.0675 0.0795)
+(-0.0060 0.0705 0.0795)
+(-0.0030 0.0705 0.0795)
+(0.0000 0.0705 0.0795)
+(0.0030 0.0705 0.0795)
+(0.0060 0.0705 0.0795)
+(-0.0060 0.0735 0.0795)
+(-0.0030 0.0735 0.0795)
+(0.0000 0.0735 0.0795)
+(0.0030 0.0735 0.0795)
+(0.0060 0.0735 0.0795)
+(-0.0060 -0.0735 0.0825)
+(-0.0030 -0.0735 0.0825)
+(0.0000 -0.0735 0.0825)
+(0.0030 -0.0735 0.0825)
+(0.0060 -0.0735 0.0825)
+(-0.0060 -0.0705 0.0825)
+(-0.0030 -0.0705 0.0825)
+(0.0000 -0.0705 0.0825)
+(0.0030 -0.0705 0.0825)
+(0.0060 -0.0705 0.0825)
+(-0.0060 -0.0675 0.0825)
+(-0.0030 -0.0675 0.0825)
+(0.0000 -0.0675 0.0825)
+(0.0030 -0.0675 0.0825)
+(0.0060 -0.0675 0.0825)
+(-0.0060 -0.0645 0.0825)
+(-0.0030 -0.0645 0.0825)
+(0.0000 -0.0645 0.0825)
+(0.0030 -0.0645 0.0825)
+(0.0060 -0.0645 0.0825)
+(-0.0060 -0.0615 0.0825)
+(-0.0030 -0.0615 0.0825)
+(0.0000 -0.0615 0.0825)
+(0.0030 -0.0615 0.0825)
+(0.0060 -0.0615 0.0825)
+(-0.0060 -0.0585 0.0825)
+(-0.0030 -0.0585 0.0825)
+(0.0000 -0.0585 0.0825)
+(0.0030 -0.0585 0.0825)
+(0.0060 -0.0585 0.0825)
+(-0.0060 -0.0555 0.0825)
+(-0.0030 -0.0555 0.0825)
+(0.0000 -0.0555 0.0825)
+(0.0030 -0.0555 0.0825)
+(0.0060 -0.0555 0.0825)
+(-0.0060 -0.0525 0.0825)
+(-0.0030 -0.0525 0.0825)
+(0.0000 -0.0525 0.0825)
+(0.0030 -0.0525 0.0825)
+(0.0060 -0.0525 0.0825)
+(-0.0060 -0.0495 0.0825)
+(-0.0030 -0.0495 0.0825)
+(0.0000 -0.0495 0.0825)
+(0.0030 -0.0495 0.0825)
+(0.0060 -0.0495 0.0825)
+(-0.0060 -0.0465 0.0825)
+(-0.0030 -0.0465 0.0825)
+(0.0000 -0.0465 0.0825)
+(0.0030 -0.0465 0.0825)
+(0.0060 -0.0465 0.0825)
+(-0.0060 -0.0435 0.0825)
+(-0.0030 -0.0435 0.0825)
+(0.0000 -0.0435 0.0825)
+(0.0030 -0.0435 0.0825)
+(0.0060 -0.0435 0.0825)
+(-0.0060 -0.0405 0.0825)
+(-0.0030 -0.0405 0.0825)
+(0.0000 -0.0405 0.0825)
+(0.0030 -0.0405 0.0825)
+(0.0060 -0.0405 0.0825)
+(-0.0060 -0.0375 0.0825)
+(-0.0030 -0.0375 0.0825)
+(0.0000 -0.0375 0.0825)
+(0.0030 -0.0375 0.0825)
+(0.0060 -0.0375 0.0825)
+(-0.0060 -0.0345 0.0825)
+(-0.0030 -0.0345 0.0825)
+(0.0000 -0.0345 0.0825)
+(0.0030 -0.0345 0.0825)
+(0.0060 -0.0345 0.0825)
+(-0.0060 -0.0315 0.0825)
+(-0.0030 -0.0315 0.0825)
+(0.0000 -0.0315 0.0825)
+(0.0030 -0.0315 0.0825)
+(0.0060 -0.0315 0.0825)
+(-0.0060 -0.0285 0.0825)
+(-0.0030 -0.0285 0.0825)
+(0.0000 -0.0285 0.0825)
+(0.0030 -0.0285 0.0825)
+(0.0060 -0.0285 0.0825)
+(-0.0060 -0.0255 0.0825)
+(-0.0030 -0.0255 0.0825)
+(0.0000 -0.0255 0.0825)
+(0.0030 -0.0255 0.0825)
+(0.0060 -0.0255 0.0825)
+(-0.0060 -0.0225 0.0825)
+(-0.0030 -0.0225 0.0825)
+(0.0000 -0.0225 0.0825)
+(0.0030 -0.0225 0.0825)
+(0.0060 -0.0225 0.0825)
+(-0.0060 -0.0195 0.0825)
+(-0.0030 -0.0195 0.0825)
+(0.0000 -0.0195 0.0825)
+(0.0030 -0.0195 0.0825)
+(0.0060 -0.0195 0.0825)
+(-0.0060 -0.0165 0.0825)
+(-0.0030 -0.0165 0.0825)
+(0.0000 -0.0165 0.0825)
+(0.0030 -0.0165 0.0825)
+(0.0060 -0.0165 0.0825)
+(-0.0060 -0.0135 0.0825)
+(-0.0030 -0.0135 0.0825)
+(0.0000 -0.0135 0.0825)
+(0.0030 -0.0135 0.0825)
+(0.0060 -0.0135 0.0825)
+(-0.0060 -0.0105 0.0825)
+(-0.0030 -0.0105 0.0825)
+(0.0000 -0.0105 0.0825)
+(0.0030 -0.0105 0.0825)
+(0.0060 -0.0105 0.0825)
+(-0.0060 -0.0075 0.0825)
+(-0.0030 -0.0075 0.0825)
+(0.0000 -0.0075 0.0825)
+(0.0030 -0.0075 0.0825)
+(0.0060 -0.0075 0.0825)
+(-0.0060 -0.0045 0.0825)
+(-0.0030 -0.0045 0.0825)
+(0.0000 -0.0045 0.0825)
+(0.0030 -0.0045 0.0825)
+(0.0060 -0.0045 0.0825)
+(-0.0060 -0.0015 0.0825)
+(-0.0030 -0.0015 0.0825)
+(0.0000 -0.0015 0.0825)
+(0.0030 -0.0015 0.0825)
+(0.0060 -0.0015 0.0825)
+(-0.0060 0.0015 0.0825)
+(-0.0030 0.0015 0.0825)
+(0.0000 0.0015 0.0825)
+(0.0030 0.0015 0.0825)
+(0.0060 0.0015 0.0825)
+(-0.0060 0.0045 0.0825)
+(-0.0030 0.0045 0.0825)
+(0.0000 0.0045 0.0825)
+(0.0030 0.0045 0.0825)
+(0.0060 0.0045 0.0825)
+(-0.0060 0.0075 0.0825)
+(-0.0030 0.0075 0.0825)
+(0.0000 0.0075 0.0825)
+(0.0030 0.0075 0.0825)
+(0.0060 0.0075 0.0825)
+(-0.0060 0.0105 0.0825)
+(-0.0030 0.0105 0.0825)
+(0.0000 0.0105 0.0825)
+(0.0030 0.0105 0.0825)
+(0.0060 0.0105 0.0825)
+(-0.0060 0.0135 0.0825)
+(-0.0030 0.0135 0.0825)
+(0.0000 0.0135 0.0825)
+(0.0030 0.0135 0.0825)
+(0.0060 0.0135 0.0825)
+(-0.0060 0.0165 0.0825)
+(-0.0030 0.0165 0.0825)
+(0.0000 0.0165 0.0825)
+(0.0030 0.0165 0.0825)
+(0.0060 0.0165 0.0825)
+(-0.0060 0.0195 0.0825)
+(-0.0030 0.0195 0.0825)
+(0.0000 0.0195 0.0825)
+(0.0030 0.0195 0.0825)
+(0.0060 0.0195 0.0825)
+(-0.0060 0.0225 0.0825)
+(-0.0030 0.0225 0.0825)
+(0.0000 0.0225 0.0825)
+(0.0030 0.0225 0.0825)
+(0.0060 0.0225 0.0825)
+(-0.0060 0.0255 0.0825)
+(-0.0030 0.0255 0.0825)
+(0.0000 0.0255 0.0825)
+(0.0030 0.0255 0.0825)
+(0.0060 0.0255 0.0825)
+(-0.0060 0.0285 0.0825)
+(-0.0030 0.0285 0.0825)
+(0.0000 0.0285 0.0825)
+(0.0030 0.0285 0.0825)
+(0.0060 0.0285 0.0825)
+(-0.0060 0.0315 0.0825)
+(-0.0030 0.0315 0.0825)
+(0.0000 0.0315 0.0825)
+(0.0030 0.0315 0.0825)
+(0.0060 0.0315 0.0825)
+(-0.0060 0.0345 0.0825)
+(-0.0030 0.0345 0.0825)
+(0.0000 0.0345 0.0825)
+(0.0030 0.0345 0.0825)
+(0.0060 0.0345 0.0825)
+(-0.0060 0.0375 0.0825)
+(-0.0030 0.0375 0.0825)
+(0.0000 0.0375 0.0825)
+(0.0030 0.0375 0.0825)
+(0.0060 0.0375 0.0825)
+(-0.0060 0.0405 0.0825)
+(-0.0030 0.0405 0.0825)
+(0.0000 0.0405 0.0825)
+(0.0030 0.0405 0.0825)
+(0.0060 0.0405 0.0825)
+(-0.0060 0.0435 0.0825)
+(-0.0030 0.0435 0.0825)
+(0.0000 0.0435 0.0825)
+(0.0030 0.0435 0.0825)
+(0.0060 0.0435 0.0825)
+(-0.0060 0.0465 0.0825)
+(-0.0030 0.0465 0.0825)
+(0.0000 0.0465 0.0825)
+(0.0030 0.0465 0.0825)
+(0.0060 0.0465 0.0825)
+(-0.0060 0.0495 0.0825)
+(-0.0030 0.0495 0.0825)
+(0.0000 0.0495 0.0825)
+(0.0030 0.0495 0.0825)
+(0.0060 0.0495 0.0825)
+(-0.0060 0.0525 0.0825)
+(-0.0030 0.0525 0.0825)
+(0.0000 0.0525 0.0825)
+(0.0030 0.0525 0.0825)
+(0.0060 0.0525 0.0825)
+(-0.0060 0.0555 0.0825)
+(-0.0030 0.0555 0.0825)
+(0.0000 0.0555 0.0825)
+(0.0030 0.0555 0.0825)
+(0.0060 0.0555 0.0825)
+(-0.0060 0.0585 0.0825)
+(-0.0030 0.0585 0.0825)
+(0.0000 0.0585 0.0825)
+(0.0030 0.0585 0.0825)
+(0.0060 0.0585 0.0825)
+(-0.0060 0.0615 0.0825)
+(-0.0030 0.0615 0.0825)
+(0.0000 0.0615 0.0825)
+(0.0030 0.0615 0.0825)
+(0.0060 0.0615 0.0825)
+(-0.0060 0.0645 0.0825)
+(-0.0030 0.0645 0.0825)
+(0.0000 0.0645 0.0825)
+(0.0030 0.0645 0.0825)
+(0.0060 0.0645 0.0825)
+(-0.0060 0.0675 0.0825)
+(-0.0030 0.0675 0.0825)
+(0.0000 0.0675 0.0825)
+(0.0030 0.0675 0.0825)
+(0.0060 0.0675 0.0825)
+(-0.0060 0.0705 0.0825)
+(-0.0030 0.0705 0.0825)
+(0.0000 0.0705 0.0825)
+(0.0030 0.0705 0.0825)
+(0.0060 0.0705 0.0825)
+(-0.0060 0.0735 0.0825)
+(-0.0030 0.0735 0.0825)
+(0.0000 0.0735 0.0825)
+(0.0030 0.0735 0.0825)
+(0.0060 0.0735 0.0825)
+(-0.0060 -0.0735 0.0855)
+(-0.0030 -0.0735 0.0855)
+(0.0000 -0.0735 0.0855)
+(0.0030 -0.0735 0.0855)
+(0.0060 -0.0735 0.0855)
+(-0.0060 -0.0705 0.0855)
+(-0.0030 -0.0705 0.0855)
+(0.0000 -0.0705 0.0855)
+(0.0030 -0.0705 0.0855)
+(0.0060 -0.0705 0.0855)
+(-0.0060 -0.0675 0.0855)
+(-0.0030 -0.0675 0.0855)
+(0.0000 -0.0675 0.0855)
+(0.0030 -0.0675 0.0855)
+(0.0060 -0.0675 0.0855)
+(-0.0060 -0.0645 0.0855)
+(-0.0030 -0.0645 0.0855)
+(0.0000 -0.0645 0.0855)
+(0.0030 -0.0645 0.0855)
+(0.0060 -0.0645 0.0855)
+(-0.0060 -0.0615 0.0855)
+(-0.0030 -0.0615 0.0855)
+(0.0000 -0.0615 0.0855)
+(0.0030 -0.0615 0.0855)
+(0.0060 -0.0615 0.0855)
+(-0.0060 -0.0585 0.0855)
+(-0.0030 -0.0585 0.0855)
+(0.0000 -0.0585 0.0855)
+(0.0030 -0.0585 0.0855)
+(0.0060 -0.0585 0.0855)
+(-0.0060 -0.0555 0.0855)
+(-0.0030 -0.0555 0.0855)
+(0.0000 -0.0555 0.0855)
+(0.0030 -0.0555 0.0855)
+(0.0060 -0.0555 0.0855)
+(-0.0060 -0.0525 0.0855)
+(-0.0030 -0.0525 0.0855)
+(0.0000 -0.0525 0.0855)
+(0.0030 -0.0525 0.0855)
+(0.0060 -0.0525 0.0855)
+(-0.0060 -0.0495 0.0855)
+(-0.0030 -0.0495 0.0855)
+(0.0000 -0.0495 0.0855)
+(0.0030 -0.0495 0.0855)
+(0.0060 -0.0495 0.0855)
+(-0.0060 -0.0465 0.0855)
+(-0.0030 -0.0465 0.0855)
+(0.0000 -0.0465 0.0855)
+(0.0030 -0.0465 0.0855)
+(0.0060 -0.0465 0.0855)
+(-0.0060 -0.0435 0.0855)
+(-0.0030 -0.0435 0.0855)
+(0.0000 -0.0435 0.0855)
+(0.0030 -0.0435 0.0855)
+(0.0060 -0.0435 0.0855)
+(-0.0060 -0.0405 0.0855)
+(-0.0030 -0.0405 0.0855)
+(0.0000 -0.0405 0.0855)
+(0.0030 -0.0405 0.0855)
+(0.0060 -0.0405 0.0855)
+(-0.0060 -0.0375 0.0855)
+(-0.0030 -0.0375 0.0855)
+(0.0000 -0.0375 0.0855)
+(0.0030 -0.0375 0.0855)
+(0.0060 -0.0375 0.0855)
+(-0.0060 -0.0345 0.0855)
+(-0.0030 -0.0345 0.0855)
+(0.0000 -0.0345 0.0855)
+(0.0030 -0.0345 0.0855)
+(0.0060 -0.0345 0.0855)
+(-0.0060 -0.0315 0.0855)
+(-0.0030 -0.0315 0.0855)
+(0.0000 -0.0315 0.0855)
+(0.0030 -0.0315 0.0855)
+(0.0060 -0.0315 0.0855)
+(-0.0060 -0.0285 0.0855)
+(-0.0030 -0.0285 0.0855)
+(0.0000 -0.0285 0.0855)
+(0.0030 -0.0285 0.0855)
+(0.0060 -0.0285 0.0855)
+(-0.0060 -0.0255 0.0855)
+(-0.0030 -0.0255 0.0855)
+(0.0000 -0.0255 0.0855)
+(0.0030 -0.0255 0.0855)
+(0.0060 -0.0255 0.0855)
+(-0.0060 -0.0225 0.0855)
+(-0.0030 -0.0225 0.0855)
+(0.0000 -0.0225 0.0855)
+(0.0030 -0.0225 0.0855)
+(0.0060 -0.0225 0.0855)
+(-0.0060 -0.0195 0.0855)
+(-0.0030 -0.0195 0.0855)
+(0.0000 -0.0195 0.0855)
+(0.0030 -0.0195 0.0855)
+(0.0060 -0.0195 0.0855)
+(-0.0060 -0.0165 0.0855)
+(-0.0030 -0.0165 0.0855)
+(0.0000 -0.0165 0.0855)
+(0.0030 -0.0165 0.0855)
+(0.0060 -0.0165 0.0855)
+(-0.0060 -0.0135 0.0855)
+(-0.0030 -0.0135 0.0855)
+(0.0000 -0.0135 0.0855)
+(0.0030 -0.0135 0.0855)
+(0.0060 -0.0135 0.0855)
+(-0.0060 -0.0105 0.0855)
+(-0.0030 -0.0105 0.0855)
+(0.0000 -0.0105 0.0855)
+(0.0030 -0.0105 0.0855)
+(0.0060 -0.0105 0.0855)
+(-0.0060 -0.0075 0.0855)
+(-0.0030 -0.0075 0.0855)
+(0.0000 -0.0075 0.0855)
+(0.0030 -0.0075 0.0855)
+(0.0060 -0.0075 0.0855)
+(-0.0060 -0.0045 0.0855)
+(-0.0030 -0.0045 0.0855)
+(0.0000 -0.0045 0.0855)
+(0.0030 -0.0045 0.0855)
+(0.0060 -0.0045 0.0855)
+(-0.0060 -0.0015 0.0855)
+(-0.0030 -0.0015 0.0855)
+(0.0000 -0.0015 0.0855)
+(0.0030 -0.0015 0.0855)
+(0.0060 -0.0015 0.0855)
+(-0.0060 0.0015 0.0855)
+(-0.0030 0.0015 0.0855)
+(0.0000 0.0015 0.0855)
+(0.0030 0.0015 0.0855)
+(0.0060 0.0015 0.0855)
+(-0.0060 0.0045 0.0855)
+(-0.0030 0.0045 0.0855)
+(0.0000 0.0045 0.0855)
+(0.0030 0.0045 0.0855)
+(0.0060 0.0045 0.0855)
+(-0.0060 0.0075 0.0855)
+(-0.0030 0.0075 0.0855)
+(0.0000 0.0075 0.0855)
+(0.0030 0.0075 0.0855)
+(0.0060 0.0075 0.0855)
+(-0.0060 0.0105 0.0855)
+(-0.0030 0.0105 0.0855)
+(0.0000 0.0105 0.0855)
+(0.0030 0.0105 0.0855)
+(0.0060 0.0105 0.0855)
+(-0.0060 0.0135 0.0855)
+(-0.0030 0.0135 0.0855)
+(0.0000 0.0135 0.0855)
+(0.0030 0.0135 0.0855)
+(0.0060 0.0135 0.0855)
+(-0.0060 0.0165 0.0855)
+(-0.0030 0.0165 0.0855)
+(0.0000 0.0165 0.0855)
+(0.0030 0.0165 0.0855)
+(0.0060 0.0165 0.0855)
+(-0.0060 0.0195 0.0855)
+(-0.0030 0.0195 0.0855)
+(0.0000 0.0195 0.0855)
+(0.0030 0.0195 0.0855)
+(0.0060 0.0195 0.0855)
+(-0.0060 0.0225 0.0855)
+(-0.0030 0.0225 0.0855)
+(0.0000 0.0225 0.0855)
+(0.0030 0.0225 0.0855)
+(0.0060 0.0225 0.0855)
+(-0.0060 0.0255 0.0855)
+(-0.0030 0.0255 0.0855)
+(0.0000 0.0255 0.0855)
+(0.0030 0.0255 0.0855)
+(0.0060 0.0255 0.0855)
+(-0.0060 0.0285 0.0855)
+(-0.0030 0.0285 0.0855)
+(0.0000 0.0285 0.0855)
+(0.0030 0.0285 0.0855)
+(0.0060 0.0285 0.0855)
+(-0.0060 0.0315 0.0855)
+(-0.0030 0.0315 0.0855)
+(0.0000 0.0315 0.0855)
+(0.0030 0.0315 0.0855)
+(0.0060 0.0315 0.0855)
+(-0.0060 0.0345 0.0855)
+(-0.0030 0.0345 0.0855)
+(0.0000 0.0345 0.0855)
+(0.0030 0.0345 0.0855)
+(0.0060 0.0345 0.0855)
+(-0.0060 0.0375 0.0855)
+(-0.0030 0.0375 0.0855)
+(0.0000 0.0375 0.0855)
+(0.0030 0.0375 0.0855)
+(0.0060 0.0375 0.0855)
+(-0.0060 0.0405 0.0855)
+(-0.0030 0.0405 0.0855)
+(0.0000 0.0405 0.0855)
+(0.0030 0.0405 0.0855)
+(0.0060 0.0405 0.0855)
+(-0.0060 0.0435 0.0855)
+(-0.0030 0.0435 0.0855)
+(0.0000 0.0435 0.0855)
+(0.0030 0.0435 0.0855)
+(0.0060 0.0435 0.0855)
+(-0.0060 0.0465 0.0855)
+(-0.0030 0.0465 0.0855)
+(0.0000 0.0465 0.0855)
+(0.0030 0.0465 0.0855)
+(0.0060 0.0465 0.0855)
+(-0.0060 0.0495 0.0855)
+(-0.0030 0.0495 0.0855)
+(0.0000 0.0495 0.0855)
+(0.0030 0.0495 0.0855)
+(0.0060 0.0495 0.0855)
+(-0.0060 0.0525 0.0855)
+(-0.0030 0.0525 0.0855)
+(0.0000 0.0525 0.0855)
+(0.0030 0.0525 0.0855)
+(0.0060 0.0525 0.0855)
+(-0.0060 0.0555 0.0855)
+(-0.0030 0.0555 0.0855)
+(0.0000 0.0555 0.0855)
+(0.0030 0.0555 0.0855)
+(0.0060 0.0555 0.0855)
+(-0.0060 0.0585 0.0855)
+(-0.0030 0.0585 0.0855)
+(0.0000 0.0585 0.0855)
+(0.0030 0.0585 0.0855)
+(0.0060 0.0585 0.0855)
+(-0.0060 0.0615 0.0855)
+(-0.0030 0.0615 0.0855)
+(0.0000 0.0615 0.0855)
+(0.0030 0.0615 0.0855)
+(0.0060 0.0615 0.0855)
+(-0.0060 0.0645 0.0855)
+(-0.0030 0.0645 0.0855)
+(0.0000 0.0645 0.0855)
+(0.0030 0.0645 0.0855)
+(0.0060 0.0645 0.0855)
+(-0.0060 0.0675 0.0855)
+(-0.0030 0.0675 0.0855)
+(0.0000 0.0675 0.0855)
+(0.0030 0.0675 0.0855)
+(0.0060 0.0675 0.0855)
+(-0.0060 0.0705 0.0855)
+(-0.0030 0.0705 0.0855)
+(0.0000 0.0705 0.0855)
+(0.0030 0.0705 0.0855)
+(0.0060 0.0705 0.0855)
+(-0.0060 0.0735 0.0855)
+(-0.0030 0.0735 0.0855)
+(0.0000 0.0735 0.0855)
+(0.0030 0.0735 0.0855)
+(0.0060 0.0735 0.0855)
+(-0.0060 -0.0735 0.0885)
+(-0.0030 -0.0735 0.0885)
+(0.0000 -0.0735 0.0885)
+(0.0030 -0.0735 0.0885)
+(0.0060 -0.0735 0.0885)
+(-0.0060 -0.0705 0.0885)
+(-0.0030 -0.0705 0.0885)
+(0.0000 -0.0705 0.0885)
+(0.0030 -0.0705 0.0885)
+(0.0060 -0.0705 0.0885)
+(-0.0060 -0.0675 0.0885)
+(-0.0030 -0.0675 0.0885)
+(0.0000 -0.0675 0.0885)
+(0.0030 -0.0675 0.0885)
+(0.0060 -0.0675 0.0885)
+(-0.0060 -0.0645 0.0885)
+(-0.0030 -0.0645 0.0885)
+(0.0000 -0.0645 0.0885)
+(0.0030 -0.0645 0.0885)
+(0.0060 -0.0645 0.0885)
+(-0.0060 -0.0615 0.0885)
+(-0.0030 -0.0615 0.0885)
+(0.0000 -0.0615 0.0885)
+(0.0030 -0.0615 0.0885)
+(0.0060 -0.0615 0.0885)
+(-0.0060 -0.0585 0.0885)
+(-0.0030 -0.0585 0.0885)
+(0.0000 -0.0585 0.0885)
+(0.0030 -0.0585 0.0885)
+(0.0060 -0.0585 0.0885)
+(-0.0060 -0.0555 0.0885)
+(-0.0030 -0.0555 0.0885)
+(0.0000 -0.0555 0.0885)
+(0.0030 -0.0555 0.0885)
+(0.0060 -0.0555 0.0885)
+(-0.0060 -0.0525 0.0885)
+(-0.0030 -0.0525 0.0885)
+(0.0000 -0.0525 0.0885)
+(0.0030 -0.0525 0.0885)
+(0.0060 -0.0525 0.0885)
+(-0.0060 -0.0495 0.0885)
+(-0.0030 -0.0495 0.0885)
+(0.0000 -0.0495 0.0885)
+(0.0030 -0.0495 0.0885)
+(0.0060 -0.0495 0.0885)
+(-0.0060 -0.0465 0.0885)
+(-0.0030 -0.0465 0.0885)
+(0.0000 -0.0465 0.0885)
+(0.0030 -0.0465 0.0885)
+(0.0060 -0.0465 0.0885)
+(-0.0060 -0.0435 0.0885)
+(-0.0030 -0.0435 0.0885)
+(0.0000 -0.0435 0.0885)
+(0.0030 -0.0435 0.0885)
+(0.0060 -0.0435 0.0885)
+(-0.0060 -0.0405 0.0885)
+(-0.0030 -0.0405 0.0885)
+(0.0000 -0.0405 0.0885)
+(0.0030 -0.0405 0.0885)
+(0.0060 -0.0405 0.0885)
+(-0.0060 -0.0375 0.0885)
+(-0.0030 -0.0375 0.0885)
+(0.0000 -0.0375 0.0885)
+(0.0030 -0.0375 0.0885)
+(0.0060 -0.0375 0.0885)
+(-0.0060 -0.0345 0.0885)
+(-0.0030 -0.0345 0.0885)
+(0.0000 -0.0345 0.0885)
+(0.0030 -0.0345 0.0885)
+(0.0060 -0.0345 0.0885)
+(-0.0060 -0.0315 0.0885)
+(-0.0030 -0.0315 0.0885)
+(0.0000 -0.0315 0.0885)
+(0.0030 -0.0315 0.0885)
+(0.0060 -0.0315 0.0885)
+(-0.0060 -0.0285 0.0885)
+(-0.0030 -0.0285 0.0885)
+(0.0000 -0.0285 0.0885)
+(0.0030 -0.0285 0.0885)
+(0.0060 -0.0285 0.0885)
+(-0.0060 -0.0255 0.0885)
+(-0.0030 -0.0255 0.0885)
+(0.0000 -0.0255 0.0885)
+(0.0030 -0.0255 0.0885)
+(0.0060 -0.0255 0.0885)
+(-0.0060 -0.0225 0.0885)
+(-0.0030 -0.0225 0.0885)
+(0.0000 -0.0225 0.0885)
+(0.0030 -0.0225 0.0885)
+(0.0060 -0.0225 0.0885)
+(-0.0060 -0.0195 0.0885)
+(-0.0030 -0.0195 0.0885)
+(0.0000 -0.0195 0.0885)
+(0.0030 -0.0195 0.0885)
+(0.0060 -0.0195 0.0885)
+(-0.0060 -0.0165 0.0885)
+(-0.0030 -0.0165 0.0885)
+(0.0000 -0.0165 0.0885)
+(0.0030 -0.0165 0.0885)
+(0.0060 -0.0165 0.0885)
+(-0.0060 -0.0135 0.0885)
+(-0.0030 -0.0135 0.0885)
+(0.0000 -0.0135 0.0885)
+(0.0030 -0.0135 0.0885)
+(0.0060 -0.0135 0.0885)
+(-0.0060 -0.0105 0.0885)
+(-0.0030 -0.0105 0.0885)
+(0.0000 -0.0105 0.0885)
+(0.0030 -0.0105 0.0885)
+(0.0060 -0.0105 0.0885)
+(-0.0060 -0.0075 0.0885)
+(-0.0030 -0.0075 0.0885)
+(0.0000 -0.0075 0.0885)
+(0.0030 -0.0075 0.0885)
+(0.0060 -0.0075 0.0885)
+(-0.0060 -0.0045 0.0885)
+(-0.0030 -0.0045 0.0885)
+(0.0000 -0.0045 0.0885)
+(0.0030 -0.0045 0.0885)
+(0.0060 -0.0045 0.0885)
+(-0.0060 -0.0015 0.0885)
+(-0.0030 -0.0015 0.0885)
+(0.0000 -0.0015 0.0885)
+(0.0030 -0.0015 0.0885)
+(0.0060 -0.0015 0.0885)
+(-0.0060 0.0015 0.0885)
+(-0.0030 0.0015 0.0885)
+(0.0000 0.0015 0.0885)
+(0.0030 0.0015 0.0885)
+(0.0060 0.0015 0.0885)
+(-0.0060 0.0045 0.0885)
+(-0.0030 0.0045 0.0885)
+(0.0000 0.0045 0.0885)
+(0.0030 0.0045 0.0885)
+(0.0060 0.0045 0.0885)
+(-0.0060 0.0075 0.0885)
+(-0.0030 0.0075 0.0885)
+(0.0000 0.0075 0.0885)
+(0.0030 0.0075 0.0885)
+(0.0060 0.0075 0.0885)
+(-0.0060 0.0105 0.0885)
+(-0.0030 0.0105 0.0885)
+(0.0000 0.0105 0.0885)
+(0.0030 0.0105 0.0885)
+(0.0060 0.0105 0.0885)
+(-0.0060 0.0135 0.0885)
+(-0.0030 0.0135 0.0885)
+(0.0000 0.0135 0.0885)
+(0.0030 0.0135 0.0885)
+(0.0060 0.0135 0.0885)
+(-0.0060 0.0165 0.0885)
+(-0.0030 0.0165 0.0885)
+(0.0000 0.0165 0.0885)
+(0.0030 0.0165 0.0885)
+(0.0060 0.0165 0.0885)
+(-0.0060 0.0195 0.0885)
+(-0.0030 0.0195 0.0885)
+(0.0000 0.0195 0.0885)
+(0.0030 0.0195 0.0885)
+(0.0060 0.0195 0.0885)
+(-0.0060 0.0225 0.0885)
+(-0.0030 0.0225 0.0885)
+(0.0000 0.0225 0.0885)
+(0.0030 0.0225 0.0885)
+(0.0060 0.0225 0.0885)
+(-0.0060 0.0255 0.0885)
+(-0.0030 0.0255 0.0885)
+(0.0000 0.0255 0.0885)
+(0.0030 0.0255 0.0885)
+(0.0060 0.0255 0.0885)
+(-0.0060 0.0285 0.0885)
+(-0.0030 0.0285 0.0885)
+(0.0000 0.0285 0.0885)
+(0.0030 0.0285 0.0885)
+(0.0060 0.0285 0.0885)
+(-0.0060 0.0315 0.0885)
+(-0.0030 0.0315 0.0885)
+(0.0000 0.0315 0.0885)
+(0.0030 0.0315 0.0885)
+(0.0060 0.0315 0.0885)
+(-0.0060 0.0345 0.0885)
+(-0.0030 0.0345 0.0885)
+(0.0000 0.0345 0.0885)
+(0.0030 0.0345 0.0885)
+(0.0060 0.0345 0.0885)
+(-0.0060 0.0375 0.0885)
+(-0.0030 0.0375 0.0885)
+(0.0000 0.0375 0.0885)
+(0.0030 0.0375 0.0885)
+(0.0060 0.0375 0.0885)
+(-0.0060 0.0405 0.0885)
+(-0.0030 0.0405 0.0885)
+(0.0000 0.0405 0.0885)
+(0.0030 0.0405 0.0885)
+(0.0060 0.0405 0.0885)
+(-0.0060 0.0435 0.0885)
+(-0.0030 0.0435 0.0885)
+(0.0000 0.0435 0.0885)
+(0.0030 0.0435 0.0885)
+(0.0060 0.0435 0.0885)
+(-0.0060 0.0465 0.0885)
+(-0.0030 0.0465 0.0885)
+(0.0000 0.0465 0.0885)
+(0.0030 0.0465 0.0885)
+(0.0060 0.0465 0.0885)
+(-0.0060 0.0495 0.0885)
+(-0.0030 0.0495 0.0885)
+(0.0000 0.0495 0.0885)
+(0.0030 0.0495 0.0885)
+(0.0060 0.0495 0.0885)
+(-0.0060 0.0525 0.0885)
+(-0.0030 0.0525 0.0885)
+(0.0000 0.0525 0.0885)
+(0.0030 0.0525 0.0885)
+(0.0060 0.0525 0.0885)
+(-0.0060 0.0555 0.0885)
+(-0.0030 0.0555 0.0885)
+(0.0000 0.0555 0.0885)
+(0.0030 0.0555 0.0885)
+(0.0060 0.0555 0.0885)
+(-0.0060 0.0585 0.0885)
+(-0.0030 0.0585 0.0885)
+(0.0000 0.0585 0.0885)
+(0.0030 0.0585 0.0885)
+(0.0060 0.0585 0.0885)
+(-0.0060 0.0615 0.0885)
+(-0.0030 0.0615 0.0885)
+(0.0000 0.0615 0.0885)
+(0.0030 0.0615 0.0885)
+(0.0060 0.0615 0.0885)
+(-0.0060 0.0645 0.0885)
+(-0.0030 0.0645 0.0885)
+(0.0000 0.0645 0.0885)
+(0.0030 0.0645 0.0885)
+(0.0060 0.0645 0.0885)
+(-0.0060 0.0675 0.0885)
+(-0.0030 0.0675 0.0885)
+(0.0000 0.0675 0.0885)
+(0.0030 0.0675 0.0885)
+(0.0060 0.0675 0.0885)
+(-0.0060 0.0705 0.0885)
+(-0.0030 0.0705 0.0885)
+(0.0000 0.0705 0.0885)
+(0.0030 0.0705 0.0885)
+(0.0060 0.0705 0.0885)
+(-0.0060 0.0735 0.0885)
+(-0.0030 0.0735 0.0885)
+(0.0000 0.0735 0.0885)
+(0.0030 0.0735 0.0885)
+(0.0060 0.0735 0.0885)
+(-0.0060 -0.0735 0.0915)
+(-0.0030 -0.0735 0.0915)
+(0.0000 -0.0735 0.0915)
+(0.0030 -0.0735 0.0915)
+(0.0060 -0.0735 0.0915)
+(-0.0060 -0.0705 0.0915)
+(-0.0030 -0.0705 0.0915)
+(0.0000 -0.0705 0.0915)
+(0.0030 -0.0705 0.0915)
+(0.0060 -0.0705 0.0915)
+(-0.0060 -0.0675 0.0915)
+(-0.0030 -0.0675 0.0915)
+(0.0000 -0.0675 0.0915)
+(0.0030 -0.0675 0.0915)
+(0.0060 -0.0675 0.0915)
+(-0.0060 -0.0645 0.0915)
+(-0.0030 -0.0645 0.0915)
+(0.0000 -0.0645 0.0915)
+(0.0030 -0.0645 0.0915)
+(0.0060 -0.0645 0.0915)
+(-0.0060 -0.0615 0.0915)
+(-0.0030 -0.0615 0.0915)
+(0.0000 -0.0615 0.0915)
+(0.0030 -0.0615 0.0915)
+(0.0060 -0.0615 0.0915)
+(-0.0060 -0.0585 0.0915)
+(-0.0030 -0.0585 0.0915)
+(0.0000 -0.0585 0.0915)
+(0.0030 -0.0585 0.0915)
+(0.0060 -0.0585 0.0915)
+(-0.0060 -0.0555 0.0915)
+(-0.0030 -0.0555 0.0915)
+(0.0000 -0.0555 0.0915)
+(0.0030 -0.0555 0.0915)
+(0.0060 -0.0555 0.0915)
+(-0.0060 -0.0525 0.0915)
+(-0.0030 -0.0525 0.0915)
+(0.0000 -0.0525 0.0915)
+(0.0030 -0.0525 0.0915)
+(0.0060 -0.0525 0.0915)
+(-0.0060 -0.0495 0.0915)
+(-0.0030 -0.0495 0.0915)
+(0.0000 -0.0495 0.0915)
+(0.0030 -0.0495 0.0915)
+(0.0060 -0.0495 0.0915)
+(-0.0060 -0.0465 0.0915)
+(-0.0030 -0.0465 0.0915)
+(0.0000 -0.0465 0.0915)
+(0.0030 -0.0465 0.0915)
+(0.0060 -0.0465 0.0915)
+(-0.0060 -0.0435 0.0915)
+(-0.0030 -0.0435 0.0915)
+(0.0000 -0.0435 0.0915)
+(0.0030 -0.0435 0.0915)
+(0.0060 -0.0435 0.0915)
+(-0.0060 -0.0405 0.0915)
+(-0.0030 -0.0405 0.0915)
+(0.0000 -0.0405 0.0915)
+(0.0030 -0.0405 0.0915)
+(0.0060 -0.0405 0.0915)
+(-0.0060 -0.0375 0.0915)
+(-0.0030 -0.0375 0.0915)
+(0.0000 -0.0375 0.0915)
+(0.0030 -0.0375 0.0915)
+(0.0060 -0.0375 0.0915)
+(-0.0060 -0.0345 0.0915)
+(-0.0030 -0.0345 0.0915)
+(0.0000 -0.0345 0.0915)
+(0.0030 -0.0345 0.0915)
+(0.0060 -0.0345 0.0915)
+(-0.0060 -0.0315 0.0915)
+(-0.0030 -0.0315 0.0915)
+(0.0000 -0.0315 0.0915)
+(0.0030 -0.0315 0.0915)
+(0.0060 -0.0315 0.0915)
+(-0.0060 -0.0285 0.0915)
+(-0.0030 -0.0285 0.0915)
+(0.0000 -0.0285 0.0915)
+(0.0030 -0.0285 0.0915)
+(0.0060 -0.0285 0.0915)
+(-0.0060 -0.0255 0.0915)
+(-0.0030 -0.0255 0.0915)
+(0.0000 -0.0255 0.0915)
+(0.0030 -0.0255 0.0915)
+(0.0060 -0.0255 0.0915)
+(-0.0060 -0.0225 0.0915)
+(-0.0030 -0.0225 0.0915)
+(0.0000 -0.0225 0.0915)
+(0.0030 -0.0225 0.0915)
+(0.0060 -0.0225 0.0915)
+(-0.0060 -0.0195 0.0915)
+(-0.0030 -0.0195 0.0915)
+(0.0000 -0.0195 0.0915)
+(0.0030 -0.0195 0.0915)
+(0.0060 -0.0195 0.0915)
+(-0.0060 -0.0165 0.0915)
+(-0.0030 -0.0165 0.0915)
+(0.0000 -0.0165 0.0915)
+(0.0030 -0.0165 0.0915)
+(0.0060 -0.0165 0.0915)
+(-0.0060 -0.0135 0.0915)
+(-0.0030 -0.0135 0.0915)
+(0.0000 -0.0135 0.0915)
+(0.0030 -0.0135 0.0915)
+(0.0060 -0.0135 0.0915)
+(-0.0060 -0.0105 0.0915)
+(-0.0030 -0.0105 0.0915)
+(0.0000 -0.0105 0.0915)
+(0.0030 -0.0105 0.0915)
+(0.0060 -0.0105 0.0915)
+(-0.0060 -0.0075 0.0915)
+(-0.0030 -0.0075 0.0915)
+(0.0000 -0.0075 0.0915)
+(0.0030 -0.0075 0.0915)
+(0.0060 -0.0075 0.0915)
+(-0.0060 -0.0045 0.0915)
+(-0.0030 -0.0045 0.0915)
+(0.0000 -0.0045 0.0915)
+(0.0030 -0.0045 0.0915)
+(0.0060 -0.0045 0.0915)
+(-0.0060 -0.0015 0.0915)
+(-0.0030 -0.0015 0.0915)
+(0.0000 -0.0015 0.0915)
+(0.0030 -0.0015 0.0915)
+(0.0060 -0.0015 0.0915)
+(-0.0060 0.0015 0.0915)
+(-0.0030 0.0015 0.0915)
+(0.0000 0.0015 0.0915)
+(0.0030 0.0015 0.0915)
+(0.0060 0.0015 0.0915)
+(-0.0060 0.0045 0.0915)
+(-0.0030 0.0045 0.0915)
+(0.0000 0.0045 0.0915)
+(0.0030 0.0045 0.0915)
+(0.0060 0.0045 0.0915)
+(-0.0060 0.0075 0.0915)
+(-0.0030 0.0075 0.0915)
+(0.0000 0.0075 0.0915)
+(0.0030 0.0075 0.0915)
+(0.0060 0.0075 0.0915)
+(-0.0060 0.0105 0.0915)
+(-0.0030 0.0105 0.0915)
+(0.0000 0.0105 0.0915)
+(0.0030 0.0105 0.0915)
+(0.0060 0.0105 0.0915)
+(-0.0060 0.0135 0.0915)
+(-0.0030 0.0135 0.0915)
+(0.0000 0.0135 0.0915)
+(0.0030 0.0135 0.0915)
+(0.0060 0.0135 0.0915)
+(-0.0060 0.0165 0.0915)
+(-0.0030 0.0165 0.0915)
+(0.0000 0.0165 0.0915)
+(0.0030 0.0165 0.0915)
+(0.0060 0.0165 0.0915)
+(-0.0060 0.0195 0.0915)
+(-0.0030 0.0195 0.0915)
+(0.0000 0.0195 0.0915)
+(0.0030 0.0195 0.0915)
+(0.0060 0.0195 0.0915)
+(-0.0060 0.0225 0.0915)
+(-0.0030 0.0225 0.0915)
+(0.0000 0.0225 0.0915)
+(0.0030 0.0225 0.0915)
+(0.0060 0.0225 0.0915)
+(-0.0060 0.0255 0.0915)
+(-0.0030 0.0255 0.0915)
+(0.0000 0.0255 0.0915)
+(0.0030 0.0255 0.0915)
+(0.0060 0.0255 0.0915)
+(-0.0060 0.0285 0.0915)
+(-0.0030 0.0285 0.0915)
+(0.0000 0.0285 0.0915)
+(0.0030 0.0285 0.0915)
+(0.0060 0.0285 0.0915)
+(-0.0060 0.0315 0.0915)
+(-0.0030 0.0315 0.0915)
+(0.0000 0.0315 0.0915)
+(0.0030 0.0315 0.0915)
+(0.0060 0.0315 0.0915)
+(-0.0060 0.0345 0.0915)
+(-0.0030 0.0345 0.0915)
+(0.0000 0.0345 0.0915)
+(0.0030 0.0345 0.0915)
+(0.0060 0.0345 0.0915)
+(-0.0060 0.0375 0.0915)
+(-0.0030 0.0375 0.0915)
+(0.0000 0.0375 0.0915)
+(0.0030 0.0375 0.0915)
+(0.0060 0.0375 0.0915)
+(-0.0060 0.0405 0.0915)
+(-0.0030 0.0405 0.0915)
+(0.0000 0.0405 0.0915)
+(0.0030 0.0405 0.0915)
+(0.0060 0.0405 0.0915)
+(-0.0060 0.0435 0.0915)
+(-0.0030 0.0435 0.0915)
+(0.0000 0.0435 0.0915)
+(0.0030 0.0435 0.0915)
+(0.0060 0.0435 0.0915)
+(-0.0060 0.0465 0.0915)
+(-0.0030 0.0465 0.0915)
+(0.0000 0.0465 0.0915)
+(0.0030 0.0465 0.0915)
+(0.0060 0.0465 0.0915)
+(-0.0060 0.0495 0.0915)
+(-0.0030 0.0495 0.0915)
+(0.0000 0.0495 0.0915)
+(0.0030 0.0495 0.0915)
+(0.0060 0.0495 0.0915)
+(-0.0060 0.0525 0.0915)
+(-0.0030 0.0525 0.0915)
+(0.0000 0.0525 0.0915)
+(0.0030 0.0525 0.0915)
+(0.0060 0.0525 0.0915)
+(-0.0060 0.0555 0.0915)
+(-0.0030 0.0555 0.0915)
+(0.0000 0.0555 0.0915)
+(0.0030 0.0555 0.0915)
+(0.0060 0.0555 0.0915)
+(-0.0060 0.0585 0.0915)
+(-0.0030 0.0585 0.0915)
+(0.0000 0.0585 0.0915)
+(0.0030 0.0585 0.0915)
+(0.0060 0.0585 0.0915)
+(-0.0060 0.0615 0.0915)
+(-0.0030 0.0615 0.0915)
+(0.0000 0.0615 0.0915)
+(0.0030 0.0615 0.0915)
+(0.0060 0.0615 0.0915)
+(-0.0060 0.0645 0.0915)
+(-0.0030 0.0645 0.0915)
+(0.0000 0.0645 0.0915)
+(0.0030 0.0645 0.0915)
+(0.0060 0.0645 0.0915)
+(-0.0060 0.0675 0.0915)
+(-0.0030 0.0675 0.0915)
+(0.0000 0.0675 0.0915)
+(0.0030 0.0675 0.0915)
+(0.0060 0.0675 0.0915)
+(-0.0060 0.0705 0.0915)
+(-0.0030 0.0705 0.0915)
+(0.0000 0.0705 0.0915)
+(0.0030 0.0705 0.0915)
+(0.0060 0.0705 0.0915)
+(-0.0060 0.0735 0.0915)
+(-0.0030 0.0735 0.0915)
+(0.0000 0.0735 0.0915)
+(0.0030 0.0735 0.0915)
+(0.0060 0.0735 0.0915)
+(-0.0060 -0.0735 0.0945)
+(-0.0030 -0.0735 0.0945)
+(0.0000 -0.0735 0.0945)
+(0.0030 -0.0735 0.0945)
+(0.0060 -0.0735 0.0945)
+(-0.0060 -0.0705 0.0945)
+(-0.0030 -0.0705 0.0945)
+(0.0000 -0.0705 0.0945)
+(0.0030 -0.0705 0.0945)
+(0.0060 -0.0705 0.0945)
+(-0.0060 -0.0675 0.0945)
+(-0.0030 -0.0675 0.0945)
+(0.0000 -0.0675 0.0945)
+(0.0030 -0.0675 0.0945)
+(0.0060 -0.0675 0.0945)
+(-0.0060 -0.0645 0.0945)
+(-0.0030 -0.0645 0.0945)
+(0.0000 -0.0645 0.0945)
+(0.0030 -0.0645 0.0945)
+(0.0060 -0.0645 0.0945)
+(-0.0060 -0.0615 0.0945)
+(-0.0030 -0.0615 0.0945)
+(0.0000 -0.0615 0.0945)
+(0.0030 -0.0615 0.0945)
+(0.0060 -0.0615 0.0945)
+(-0.0060 -0.0585 0.0945)
+(-0.0030 -0.0585 0.0945)
+(0.0000 -0.0585 0.0945)
+(0.0030 -0.0585 0.0945)
+(0.0060 -0.0585 0.0945)
+(-0.0060 -0.0555 0.0945)
+(-0.0030 -0.0555 0.0945)
+(0.0000 -0.0555 0.0945)
+(0.0030 -0.0555 0.0945)
+(0.0060 -0.0555 0.0945)
+(-0.0060 -0.0525 0.0945)
+(-0.0030 -0.0525 0.0945)
+(0.0000 -0.0525 0.0945)
+(0.0030 -0.0525 0.0945)
+(0.0060 -0.0525 0.0945)
+(-0.0060 -0.0495 0.0945)
+(-0.0030 -0.0495 0.0945)
+(0.0000 -0.0495 0.0945)
+(0.0030 -0.0495 0.0945)
+(0.0060 -0.0495 0.0945)
+(-0.0060 -0.0465 0.0945)
+(-0.0030 -0.0465 0.0945)
+(0.0000 -0.0465 0.0945)
+(0.0030 -0.0465 0.0945)
+(0.0060 -0.0465 0.0945)
+(-0.0060 -0.0435 0.0945)
+(-0.0030 -0.0435 0.0945)
+(0.0000 -0.0435 0.0945)
+(0.0030 -0.0435 0.0945)
+(0.0060 -0.0435 0.0945)
+(-0.0060 -0.0405 0.0945)
+(-0.0030 -0.0405 0.0945)
+(0.0000 -0.0405 0.0945)
+(0.0030 -0.0405 0.0945)
+(0.0060 -0.0405 0.0945)
+(-0.0060 -0.0375 0.0945)
+(-0.0030 -0.0375 0.0945)
+(0.0000 -0.0375 0.0945)
+(0.0030 -0.0375 0.0945)
+(0.0060 -0.0375 0.0945)
+(-0.0060 -0.0345 0.0945)
+(-0.0030 -0.0345 0.0945)
+(0.0000 -0.0345 0.0945)
+(0.0030 -0.0345 0.0945)
+(0.0060 -0.0345 0.0945)
+(-0.0060 -0.0315 0.0945)
+(-0.0030 -0.0315 0.0945)
+(0.0000 -0.0315 0.0945)
+(0.0030 -0.0315 0.0945)
+(0.0060 -0.0315 0.0945)
+(-0.0060 -0.0285 0.0945)
+(-0.0030 -0.0285 0.0945)
+(0.0000 -0.0285 0.0945)
+(0.0030 -0.0285 0.0945)
+(0.0060 -0.0285 0.0945)
+(-0.0060 -0.0255 0.0945)
+(-0.0030 -0.0255 0.0945)
+(0.0000 -0.0255 0.0945)
+(0.0030 -0.0255 0.0945)
+(0.0060 -0.0255 0.0945)
+(-0.0060 -0.0225 0.0945)
+(-0.0030 -0.0225 0.0945)
+(0.0000 -0.0225 0.0945)
+(0.0030 -0.0225 0.0945)
+(0.0060 -0.0225 0.0945)
+(-0.0060 -0.0195 0.0945)
+(-0.0030 -0.0195 0.0945)
+(0.0000 -0.0195 0.0945)
+(0.0030 -0.0195 0.0945)
+(0.0060 -0.0195 0.0945)
+(-0.0060 -0.0165 0.0945)
+(-0.0030 -0.0165 0.0945)
+(0.0000 -0.0165 0.0945)
+(0.0030 -0.0165 0.0945)
+(0.0060 -0.0165 0.0945)
+(-0.0060 -0.0135 0.0945)
+(-0.0030 -0.0135 0.0945)
+(0.0000 -0.0135 0.0945)
+(0.0030 -0.0135 0.0945)
+(0.0060 -0.0135 0.0945)
+(-0.0060 -0.0105 0.0945)
+(-0.0030 -0.0105 0.0945)
+(0.0000 -0.0105 0.0945)
+(0.0030 -0.0105 0.0945)
+(0.0060 -0.0105 0.0945)
+(-0.0060 -0.0075 0.0945)
+(-0.0030 -0.0075 0.0945)
+(0.0000 -0.0075 0.0945)
+(0.0030 -0.0075 0.0945)
+(0.0060 -0.0075 0.0945)
+(-0.0060 -0.0045 0.0945)
+(-0.0030 -0.0045 0.0945)
+(0.0000 -0.0045 0.0945)
+(0.0030 -0.0045 0.0945)
+(0.0060 -0.0045 0.0945)
+(-0.0060 -0.0015 0.0945)
+(-0.0030 -0.0015 0.0945)
+(0.0000 -0.0015 0.0945)
+(0.0030 -0.0015 0.0945)
+(0.0060 -0.0015 0.0945)
+(-0.0060 0.0015 0.0945)
+(-0.0030 0.0015 0.0945)
+(0.0000 0.0015 0.0945)
+(0.0030 0.0015 0.0945)
+(0.0060 0.0015 0.0945)
+(-0.0060 0.0045 0.0945)
+(-0.0030 0.0045 0.0945)
+(0.0000 0.0045 0.0945)
+(0.0030 0.0045 0.0945)
+(0.0060 0.0045 0.0945)
+(-0.0060 0.0075 0.0945)
+(-0.0030 0.0075 0.0945)
+(0.0000 0.0075 0.0945)
+(0.0030 0.0075 0.0945)
+(0.0060 0.0075 0.0945)
+(-0.0060 0.0105 0.0945)
+(-0.0030 0.0105 0.0945)
+(0.0000 0.0105 0.0945)
+(0.0030 0.0105 0.0945)
+(0.0060 0.0105 0.0945)
+(-0.0060 0.0135 0.0945)
+(-0.0030 0.0135 0.0945)
+(0.0000 0.0135 0.0945)
+(0.0030 0.0135 0.0945)
+(0.0060 0.0135 0.0945)
+(-0.0060 0.0165 0.0945)
+(-0.0030 0.0165 0.0945)
+(0.0000 0.0165 0.0945)
+(0.0030 0.0165 0.0945)
+(0.0060 0.0165 0.0945)
+(-0.0060 0.0195 0.0945)
+(-0.0030 0.0195 0.0945)
+(0.0000 0.0195 0.0945)
+(0.0030 0.0195 0.0945)
+(0.0060 0.0195 0.0945)
+(-0.0060 0.0225 0.0945)
+(-0.0030 0.0225 0.0945)
+(0.0000 0.0225 0.0945)
+(0.0030 0.0225 0.0945)
+(0.0060 0.0225 0.0945)
+(-0.0060 0.0255 0.0945)
+(-0.0030 0.0255 0.0945)
+(0.0000 0.0255 0.0945)
+(0.0030 0.0255 0.0945)
+(0.0060 0.0255 0.0945)
+(-0.0060 0.0285 0.0945)
+(-0.0030 0.0285 0.0945)
+(0.0000 0.0285 0.0945)
+(0.0030 0.0285 0.0945)
+(0.0060 0.0285 0.0945)
+(-0.0060 0.0315 0.0945)
+(-0.0030 0.0315 0.0945)
+(0.0000 0.0315 0.0945)
+(0.0030 0.0315 0.0945)
+(0.0060 0.0315 0.0945)
+(-0.0060 0.0345 0.0945)
+(-0.0030 0.0345 0.0945)
+(0.0000 0.0345 0.0945)
+(0.0030 0.0345 0.0945)
+(0.0060 0.0345 0.0945)
+(-0.0060 0.0375 0.0945)
+(-0.0030 0.0375 0.0945)
+(0.0000 0.0375 0.0945)
+(0.0030 0.0375 0.0945)
+(0.0060 0.0375 0.0945)
+(-0.0060 0.0405 0.0945)
+(-0.0030 0.0405 0.0945)
+(0.0000 0.0405 0.0945)
+(0.0030 0.0405 0.0945)
+(0.0060 0.0405 0.0945)
+(-0.0060 0.0435 0.0945)
+(-0.0030 0.0435 0.0945)
+(0.0000 0.0435 0.0945)
+(0.0030 0.0435 0.0945)
+(0.0060 0.0435 0.0945)
+(-0.0060 0.0465 0.0945)
+(-0.0030 0.0465 0.0945)
+(0.0000 0.0465 0.0945)
+(0.0030 0.0465 0.0945)
+(0.0060 0.0465 0.0945)
+(-0.0060 0.0495 0.0945)
+(-0.0030 0.0495 0.0945)
+(0.0000 0.0495 0.0945)
+(0.0030 0.0495 0.0945)
+(0.0060 0.0495 0.0945)
+(-0.0060 0.0525 0.0945)
+(-0.0030 0.0525 0.0945)
+(0.0000 0.0525 0.0945)
+(0.0030 0.0525 0.0945)
+(0.0060 0.0525 0.0945)
+(-0.0060 0.0555 0.0945)
+(-0.0030 0.0555 0.0945)
+(0.0000 0.0555 0.0945)
+(0.0030 0.0555 0.0945)
+(0.0060 0.0555 0.0945)
+(-0.0060 0.0585 0.0945)
+(-0.0030 0.0585 0.0945)
+(0.0000 0.0585 0.0945)
+(0.0030 0.0585 0.0945)
+(0.0060 0.0585 0.0945)
+(-0.0060 0.0615 0.0945)
+(-0.0030 0.0615 0.0945)
+(0.0000 0.0615 0.0945)
+(0.0030 0.0615 0.0945)
+(0.0060 0.0615 0.0945)
+(-0.0060 0.0645 0.0945)
+(-0.0030 0.0645 0.0945)
+(0.0000 0.0645 0.0945)
+(0.0030 0.0645 0.0945)
+(0.0060 0.0645 0.0945)
+(-0.0060 0.0675 0.0945)
+(-0.0030 0.0675 0.0945)
+(0.0000 0.0675 0.0945)
+(0.0030 0.0675 0.0945)
+(0.0060 0.0675 0.0945)
+(-0.0060 0.0705 0.0945)
+(-0.0030 0.0705 0.0945)
+(0.0000 0.0705 0.0945)
+(0.0030 0.0705 0.0945)
+(0.0060 0.0705 0.0945)
+(-0.0060 0.0735 0.0945)
+(-0.0030 0.0735 0.0945)
+(0.0000 0.0735 0.0945)
+(0.0030 0.0735 0.0945)
+(0.0060 0.0735 0.0945)
+(-0.0060 -0.0735 0.0975)
+(-0.0030 -0.0735 0.0975)
+(0.0000 -0.0735 0.0975)
+(0.0030 -0.0735 0.0975)
+(0.0060 -0.0735 0.0975)
+(-0.0060 -0.0705 0.0975)
+(-0.0030 -0.0705 0.0975)
+(0.0000 -0.0705 0.0975)
+(0.0030 -0.0705 0.0975)
+(0.0060 -0.0705 0.0975)
+(-0.0060 -0.0675 0.0975)
+(-0.0030 -0.0675 0.0975)
+(0.0000 -0.0675 0.0975)
+(0.0030 -0.0675 0.0975)
+(0.0060 -0.0675 0.0975)
+(-0.0060 -0.0645 0.0975)
+(-0.0030 -0.0645 0.0975)
+(0.0000 -0.0645 0.0975)
+(0.0030 -0.0645 0.0975)
+(0.0060 -0.0645 0.0975)
+(-0.0060 -0.0615 0.0975)
+(-0.0030 -0.0615 0.0975)
+(0.0000 -0.0615 0.0975)
+(0.0030 -0.0615 0.0975)
+(0.0060 -0.0615 0.0975)
+(-0.0060 -0.0585 0.0975)
+(-0.0030 -0.0585 0.0975)
+(0.0000 -0.0585 0.0975)
+(0.0030 -0.0585 0.0975)
+(0.0060 -0.0585 0.0975)
+(-0.0060 -0.0555 0.0975)
+(-0.0030 -0.0555 0.0975)
+(0.0000 -0.0555 0.0975)
+(0.0030 -0.0555 0.0975)
+(0.0060 -0.0555 0.0975)
+(-0.0060 -0.0525 0.0975)
+(-0.0030 -0.0525 0.0975)
+(0.0000 -0.0525 0.0975)
+(0.0030 -0.0525 0.0975)
+(0.0060 -0.0525 0.0975)
+(-0.0060 -0.0495 0.0975)
+(-0.0030 -0.0495 0.0975)
+(0.0000 -0.0495 0.0975)
+(0.0030 -0.0495 0.0975)
+(0.0060 -0.0495 0.0975)
+(-0.0060 -0.0465 0.0975)
+(-0.0030 -0.0465 0.0975)
+(0.0000 -0.0465 0.0975)
+(0.0030 -0.0465 0.0975)
+(0.0060 -0.0465 0.0975)
+(-0.0060 -0.0435 0.0975)
+(-0.0030 -0.0435 0.0975)
+(0.0000 -0.0435 0.0975)
+(0.0030 -0.0435 0.0975)
+(0.0060 -0.0435 0.0975)
+(-0.0060 -0.0405 0.0975)
+(-0.0030 -0.0405 0.0975)
+(0.0000 -0.0405 0.0975)
+(0.0030 -0.0405 0.0975)
+(0.0060 -0.0405 0.0975)
+(-0.0060 -0.0375 0.0975)
+(-0.0030 -0.0375 0.0975)
+(0.0000 -0.0375 0.0975)
+(0.0030 -0.0375 0.0975)
+(0.0060 -0.0375 0.0975)
+(-0.0060 -0.0345 0.0975)
+(-0.0030 -0.0345 0.0975)
+(0.0000 -0.0345 0.0975)
+(0.0030 -0.0345 0.0975)
+(0.0060 -0.0345 0.0975)
+(-0.0060 -0.0315 0.0975)
+(-0.0030 -0.0315 0.0975)
+(0.0000 -0.0315 0.0975)
+(0.0030 -0.0315 0.0975)
+(0.0060 -0.0315 0.0975)
+(-0.0060 -0.0285 0.0975)
+(-0.0030 -0.0285 0.0975)
+(0.0000 -0.0285 0.0975)
+(0.0030 -0.0285 0.0975)
+(0.0060 -0.0285 0.0975)
+(-0.0060 -0.0255 0.0975)
+(-0.0030 -0.0255 0.0975)
+(0.0000 -0.0255 0.0975)
+(0.0030 -0.0255 0.0975)
+(0.0060 -0.0255 0.0975)
+(-0.0060 -0.0225 0.0975)
+(-0.0030 -0.0225 0.0975)
+(0.0000 -0.0225 0.0975)
+(0.0030 -0.0225 0.0975)
+(0.0060 -0.0225 0.0975)
+(-0.0060 -0.0195 0.0975)
+(-0.0030 -0.0195 0.0975)
+(0.0000 -0.0195 0.0975)
+(0.0030 -0.0195 0.0975)
+(0.0060 -0.0195 0.0975)
+(-0.0060 -0.0165 0.0975)
+(-0.0030 -0.0165 0.0975)
+(0.0000 -0.0165 0.0975)
+(0.0030 -0.0165 0.0975)
+(0.0060 -0.0165 0.0975)
+(-0.0060 -0.0135 0.0975)
+(-0.0030 -0.0135 0.0975)
+(0.0000 -0.0135 0.0975)
+(0.0030 -0.0135 0.0975)
+(0.0060 -0.0135 0.0975)
+(-0.0060 -0.0105 0.0975)
+(-0.0030 -0.0105 0.0975)
+(0.0000 -0.0105 0.0975)
+(0.0030 -0.0105 0.0975)
+(0.0060 -0.0105 0.0975)
+(-0.0060 -0.0075 0.0975)
+(-0.0030 -0.0075 0.0975)
+(0.0000 -0.0075 0.0975)
+(0.0030 -0.0075 0.0975)
+(0.0060 -0.0075 0.0975)
+(-0.0060 -0.0045 0.0975)
+(-0.0030 -0.0045 0.0975)
+(0.0000 -0.0045 0.0975)
+(0.0030 -0.0045 0.0975)
+(0.0060 -0.0045 0.0975)
+(-0.0060 -0.0015 0.0975)
+(-0.0030 -0.0015 0.0975)
+(0.0000 -0.0015 0.0975)
+(0.0030 -0.0015 0.0975)
+(0.0060 -0.0015 0.0975)
+(-0.0060 0.0015 0.0975)
+(-0.0030 0.0015 0.0975)
+(0.0000 0.0015 0.0975)
+(0.0030 0.0015 0.0975)
+(0.0060 0.0015 0.0975)
+(-0.0060 0.0045 0.0975)
+(-0.0030 0.0045 0.0975)
+(0.0000 0.0045 0.0975)
+(0.0030 0.0045 0.0975)
+(0.0060 0.0045 0.0975)
+(-0.0060 0.0075 0.0975)
+(-0.0030 0.0075 0.0975)
+(0.0000 0.0075 0.0975)
+(0.0030 0.0075 0.0975)
+(0.0060 0.0075 0.0975)
+(-0.0060 0.0105 0.0975)
+(-0.0030 0.0105 0.0975)
+(0.0000 0.0105 0.0975)
+(0.0030 0.0105 0.0975)
+(0.0060 0.0105 0.0975)
+(-0.0060 0.0135 0.0975)
+(-0.0030 0.0135 0.0975)
+(0.0000 0.0135 0.0975)
+(0.0030 0.0135 0.0975)
+(0.0060 0.0135 0.0975)
+(-0.0060 0.0165 0.0975)
+(-0.0030 0.0165 0.0975)
+(0.0000 0.0165 0.0975)
+(0.0030 0.0165 0.0975)
+(0.0060 0.0165 0.0975)
+(-0.0060 0.0195 0.0975)
+(-0.0030 0.0195 0.0975)
+(0.0000 0.0195 0.0975)
+(0.0030 0.0195 0.0975)
+(0.0060 0.0195 0.0975)
+(-0.0060 0.0225 0.0975)
+(-0.0030 0.0225 0.0975)
+(0.0000 0.0225 0.0975)
+(0.0030 0.0225 0.0975)
+(0.0060 0.0225 0.0975)
+(-0.0060 0.0255 0.0975)
+(-0.0030 0.0255 0.0975)
+(0.0000 0.0255 0.0975)
+(0.0030 0.0255 0.0975)
+(0.0060 0.0255 0.0975)
+(-0.0060 0.0285 0.0975)
+(-0.0030 0.0285 0.0975)
+(0.0000 0.0285 0.0975)
+(0.0030 0.0285 0.0975)
+(0.0060 0.0285 0.0975)
+(-0.0060 0.0315 0.0975)
+(-0.0030 0.0315 0.0975)
+(0.0000 0.0315 0.0975)
+(0.0030 0.0315 0.0975)
+(0.0060 0.0315 0.0975)
+(-0.0060 0.0345 0.0975)
+(-0.0030 0.0345 0.0975)
+(0.0000 0.0345 0.0975)
+(0.0030 0.0345 0.0975)
+(0.0060 0.0345 0.0975)
+(-0.0060 0.0375 0.0975)
+(-0.0030 0.0375 0.0975)
+(0.0000 0.0375 0.0975)
+(0.0030 0.0375 0.0975)
+(0.0060 0.0375 0.0975)
+(-0.0060 0.0405 0.0975)
+(-0.0030 0.0405 0.0975)
+(0.0000 0.0405 0.0975)
+(0.0030 0.0405 0.0975)
+(0.0060 0.0405 0.0975)
+(-0.0060 0.0435 0.0975)
+(-0.0030 0.0435 0.0975)
+(0.0000 0.0435 0.0975)
+(0.0030 0.0435 0.0975)
+(0.0060 0.0435 0.0975)
+(-0.0060 0.0465 0.0975)
+(-0.0030 0.0465 0.0975)
+(0.0000 0.0465 0.0975)
+(0.0030 0.0465 0.0975)
+(0.0060 0.0465 0.0975)
+(-0.0060 0.0495 0.0975)
+(-0.0030 0.0495 0.0975)
+(0.0000 0.0495 0.0975)
+(0.0030 0.0495 0.0975)
+(0.0060 0.0495 0.0975)
+(-0.0060 0.0525 0.0975)
+(-0.0030 0.0525 0.0975)
+(0.0000 0.0525 0.0975)
+(0.0030 0.0525 0.0975)
+(0.0060 0.0525 0.0975)
+(-0.0060 0.0555 0.0975)
+(-0.0030 0.0555 0.0975)
+(0.0000 0.0555 0.0975)
+(0.0030 0.0555 0.0975)
+(0.0060 0.0555 0.0975)
+(-0.0060 0.0585 0.0975)
+(-0.0030 0.0585 0.0975)
+(0.0000 0.0585 0.0975)
+(0.0030 0.0585 0.0975)
+(0.0060 0.0585 0.0975)
+(-0.0060 0.0615 0.0975)
+(-0.0030 0.0615 0.0975)
+(0.0000 0.0615 0.0975)
+(0.0030 0.0615 0.0975)
+(0.0060 0.0615 0.0975)
+(-0.0060 0.0645 0.0975)
+(-0.0030 0.0645 0.0975)
+(0.0000 0.0645 0.0975)
+(0.0030 0.0645 0.0975)
+(0.0060 0.0645 0.0975)
+(-0.0060 0.0675 0.0975)
+(-0.0030 0.0675 0.0975)
+(0.0000 0.0675 0.0975)
+(0.0030 0.0675 0.0975)
+(0.0060 0.0675 0.0975)
+(-0.0060 0.0705 0.0975)
+(-0.0030 0.0705 0.0975)
+(0.0000 0.0705 0.0975)
+(0.0030 0.0705 0.0975)
+(0.0060 0.0705 0.0975)
+(-0.0060 0.0735 0.0975)
+(-0.0030 0.0735 0.0975)
+(0.0000 0.0735 0.0975)
+(0.0030 0.0735 0.0975)
+(0.0060 0.0735 0.0975)
+(-0.0060 -0.0735 0.1005)
+(-0.0030 -0.0735 0.1005)
+(0.0000 -0.0735 0.1005)
+(0.0030 -0.0735 0.1005)
+(0.0060 -0.0735 0.1005)
+(-0.0060 -0.0705 0.1005)
+(-0.0030 -0.0705 0.1005)
+(0.0000 -0.0705 0.1005)
+(0.0030 -0.0705 0.1005)
+(0.0060 -0.0705 0.1005)
+(-0.0060 -0.0675 0.1005)
+(-0.0030 -0.0675 0.1005)
+(0.0000 -0.0675 0.1005)
+(0.0030 -0.0675 0.1005)
+(0.0060 -0.0675 0.1005)
+(-0.0060 -0.0645 0.1005)
+(-0.0030 -0.0645 0.1005)
+(0.0000 -0.0645 0.1005)
+(0.0030 -0.0645 0.1005)
+(0.0060 -0.0645 0.1005)
+(-0.0060 -0.0615 0.1005)
+(-0.0030 -0.0615 0.1005)
+(0.0000 -0.0615 0.1005)
+(0.0030 -0.0615 0.1005)
+(0.0060 -0.0615 0.1005)
+(-0.0060 -0.0585 0.1005)
+(-0.0030 -0.0585 0.1005)
+(0.0000 -0.0585 0.1005)
+(0.0030 -0.0585 0.1005)
+(0.0060 -0.0585 0.1005)
+(-0.0060 -0.0555 0.1005)
+(-0.0030 -0.0555 0.1005)
+(0.0000 -0.0555 0.1005)
+(0.0030 -0.0555 0.1005)
+(0.0060 -0.0555 0.1005)
+(-0.0060 -0.0525 0.1005)
+(-0.0030 -0.0525 0.1005)
+(0.0000 -0.0525 0.1005)
+(0.0030 -0.0525 0.1005)
+(0.0060 -0.0525 0.1005)
+(-0.0060 -0.0495 0.1005)
+(-0.0030 -0.0495 0.1005)
+(0.0000 -0.0495 0.1005)
+(0.0030 -0.0495 0.1005)
+(0.0060 -0.0495 0.1005)
+(-0.0060 -0.0465 0.1005)
+(-0.0030 -0.0465 0.1005)
+(0.0000 -0.0465 0.1005)
+(0.0030 -0.0465 0.1005)
+(0.0060 -0.0465 0.1005)
+(-0.0060 -0.0435 0.1005)
+(-0.0030 -0.0435 0.1005)
+(0.0000 -0.0435 0.1005)
+(0.0030 -0.0435 0.1005)
+(0.0060 -0.0435 0.1005)
+(-0.0060 -0.0405 0.1005)
+(-0.0030 -0.0405 0.1005)
+(0.0000 -0.0405 0.1005)
+(0.0030 -0.0405 0.1005)
+(0.0060 -0.0405 0.1005)
+(-0.0060 -0.0375 0.1005)
+(-0.0030 -0.0375 0.1005)
+(0.0000 -0.0375 0.1005)
+(0.0030 -0.0375 0.1005)
+(0.0060 -0.0375 0.1005)
+(-0.0060 -0.0345 0.1005)
+(-0.0030 -0.0345 0.1005)
+(0.0000 -0.0345 0.1005)
+(0.0030 -0.0345 0.1005)
+(0.0060 -0.0345 0.1005)
+(-0.0060 -0.0315 0.1005)
+(-0.0030 -0.0315 0.1005)
+(0.0000 -0.0315 0.1005)
+(0.0030 -0.0315 0.1005)
+(0.0060 -0.0315 0.1005)
+(-0.0060 -0.0285 0.1005)
+(-0.0030 -0.0285 0.1005)
+(0.0000 -0.0285 0.1005)
+(0.0030 -0.0285 0.1005)
+(0.0060 -0.0285 0.1005)
+(-0.0060 -0.0255 0.1005)
+(-0.0030 -0.0255 0.1005)
+(0.0000 -0.0255 0.1005)
+(0.0030 -0.0255 0.1005)
+(0.0060 -0.0255 0.1005)
+(-0.0060 -0.0225 0.1005)
+(-0.0030 -0.0225 0.1005)
+(0.0000 -0.0225 0.1005)
+(0.0030 -0.0225 0.1005)
+(0.0060 -0.0225 0.1005)
+(-0.0060 -0.0195 0.1005)
+(-0.0030 -0.0195 0.1005)
+(0.0000 -0.0195 0.1005)
+(0.0030 -0.0195 0.1005)
+(0.0060 -0.0195 0.1005)
+(-0.0060 -0.0165 0.1005)
+(-0.0030 -0.0165 0.1005)
+(0.0000 -0.0165 0.1005)
+(0.0030 -0.0165 0.1005)
+(0.0060 -0.0165 0.1005)
+(-0.0060 -0.0135 0.1005)
+(-0.0030 -0.0135 0.1005)
+(0.0000 -0.0135 0.1005)
+(0.0030 -0.0135 0.1005)
+(0.0060 -0.0135 0.1005)
+(-0.0060 -0.0105 0.1005)
+(-0.0030 -0.0105 0.1005)
+(0.0000 -0.0105 0.1005)
+(0.0030 -0.0105 0.1005)
+(0.0060 -0.0105 0.1005)
+(-0.0060 -0.0075 0.1005)
+(-0.0030 -0.0075 0.1005)
+(0.0000 -0.0075 0.1005)
+(0.0030 -0.0075 0.1005)
+(0.0060 -0.0075 0.1005)
+(-0.0060 -0.0045 0.1005)
+(-0.0030 -0.0045 0.1005)
+(0.0000 -0.0045 0.1005)
+(0.0030 -0.0045 0.1005)
+(0.0060 -0.0045 0.1005)
+(-0.0060 -0.0015 0.1005)
+(-0.0030 -0.0015 0.1005)
+(0.0000 -0.0015 0.1005)
+(0.0030 -0.0015 0.1005)
+(0.0060 -0.0015 0.1005)
+(-0.0060 0.0015 0.1005)
+(-0.0030 0.0015 0.1005)
+(0.0000 0.0015 0.1005)
+(0.0030 0.0015 0.1005)
+(0.0060 0.0015 0.1005)
+(-0.0060 0.0045 0.1005)
+(-0.0030 0.0045 0.1005)
+(0.0000 0.0045 0.1005)
+(0.0030 0.0045 0.1005)
+(0.0060 0.0045 0.1005)
+(-0.0060 0.0075 0.1005)
+(-0.0030 0.0075 0.1005)
+(0.0000 0.0075 0.1005)
+(0.0030 0.0075 0.1005)
+(0.0060 0.0075 0.1005)
+(-0.0060 0.0105 0.1005)
+(-0.0030 0.0105 0.1005)
+(0.0000 0.0105 0.1005)
+(0.0030 0.0105 0.1005)
+(0.0060 0.0105 0.1005)
+(-0.0060 0.0135 0.1005)
+(-0.0030 0.0135 0.1005)
+(0.0000 0.0135 0.1005)
+(0.0030 0.0135 0.1005)
+(0.0060 0.0135 0.1005)
+(-0.0060 0.0165 0.1005)
+(-0.0030 0.0165 0.1005)
+(0.0000 0.0165 0.1005)
+(0.0030 0.0165 0.1005)
+(0.0060 0.0165 0.1005)
+(-0.0060 0.0195 0.1005)
+(-0.0030 0.0195 0.1005)
+(0.0000 0.0195 0.1005)
+(0.0030 0.0195 0.1005)
+(0.0060 0.0195 0.1005)
+(-0.0060 0.0225 0.1005)
+(-0.0030 0.0225 0.1005)
+(0.0000 0.0225 0.1005)
+(0.0030 0.0225 0.1005)
+(0.0060 0.0225 0.1005)
+(-0.0060 0.0255 0.1005)
+(-0.0030 0.0255 0.1005)
+(0.0000 0.0255 0.1005)
+(0.0030 0.0255 0.1005)
+(0.0060 0.0255 0.1005)
+(-0.0060 0.0285 0.1005)
+(-0.0030 0.0285 0.1005)
+(0.0000 0.0285 0.1005)
+(0.0030 0.0285 0.1005)
+(0.0060 0.0285 0.1005)
+(-0.0060 0.0315 0.1005)
+(-0.0030 0.0315 0.1005)
+(0.0000 0.0315 0.1005)
+(0.0030 0.0315 0.1005)
+(0.0060 0.0315 0.1005)
+(-0.0060 0.0345 0.1005)
+(-0.0030 0.0345 0.1005)
+(0.0000 0.0345 0.1005)
+(0.0030 0.0345 0.1005)
+(0.0060 0.0345 0.1005)
+(-0.0060 0.0375 0.1005)
+(-0.0030 0.0375 0.1005)
+(0.0000 0.0375 0.1005)
+(0.0030 0.0375 0.1005)
+(0.0060 0.0375 0.1005)
+(-0.0060 0.0405 0.1005)
+(-0.0030 0.0405 0.1005)
+(0.0000 0.0405 0.1005)
+(0.0030 0.0405 0.1005)
+(0.0060 0.0405 0.1005)
+(-0.0060 0.0435 0.1005)
+(-0.0030 0.0435 0.1005)
+(0.0000 0.0435 0.1005)
+(0.0030 0.0435 0.1005)
+(0.0060 0.0435 0.1005)
+(-0.0060 0.0465 0.1005)
+(-0.0030 0.0465 0.1005)
+(0.0000 0.0465 0.1005)
+(0.0030 0.0465 0.1005)
+(0.0060 0.0465 0.1005)
+(-0.0060 0.0495 0.1005)
+(-0.0030 0.0495 0.1005)
+(0.0000 0.0495 0.1005)
+(0.0030 0.0495 0.1005)
+(0.0060 0.0495 0.1005)
+(-0.0060 0.0525 0.1005)
+(-0.0030 0.0525 0.1005)
+(0.0000 0.0525 0.1005)
+(0.0030 0.0525 0.1005)
+(0.0060 0.0525 0.1005)
+(-0.0060 0.0555 0.1005)
+(-0.0030 0.0555 0.1005)
+(0.0000 0.0555 0.1005)
+(0.0030 0.0555 0.1005)
+(0.0060 0.0555 0.1005)
+(-0.0060 0.0585 0.1005)
+(-0.0030 0.0585 0.1005)
+(0.0000 0.0585 0.1005)
+(0.0030 0.0585 0.1005)
+(0.0060 0.0585 0.1005)
+(-0.0060 0.0615 0.1005)
+(-0.0030 0.0615 0.1005)
+(0.0000 0.0615 0.1005)
+(0.0030 0.0615 0.1005)
+(0.0060 0.0615 0.1005)
+(-0.0060 0.0645 0.1005)
+(-0.0030 0.0645 0.1005)
+(0.0000 0.0645 0.1005)
+(0.0030 0.0645 0.1005)
+(0.0060 0.0645 0.1005)
+(-0.0060 0.0675 0.1005)
+(-0.0030 0.0675 0.1005)
+(0.0000 0.0675 0.1005)
+(0.0030 0.0675 0.1005)
+(0.0060 0.0675 0.1005)
+(-0.0060 0.0705 0.1005)
+(-0.0030 0.0705 0.1005)
+(0.0000 0.0705 0.1005)
+(0.0030 0.0705 0.1005)
+(0.0060 0.0705 0.1005)
+(-0.0060 0.0735 0.1005)
+(-0.0030 0.0735 0.1005)
+(0.0000 0.0735 0.1005)
+(0.0030 0.0735 0.1005)
+(0.0060 0.0735 0.1005)
+(-0.0060 -0.0735 0.1035)
+(-0.0030 -0.0735 0.1035)
+(0.0000 -0.0735 0.1035)
+(0.0030 -0.0735 0.1035)
+(0.0060 -0.0735 0.1035)
+(-0.0060 -0.0705 0.1035)
+(-0.0030 -0.0705 0.1035)
+(0.0000 -0.0705 0.1035)
+(0.0030 -0.0705 0.1035)
+(0.0060 -0.0705 0.1035)
+(-0.0060 -0.0675 0.1035)
+(-0.0030 -0.0675 0.1035)
+(0.0000 -0.0675 0.1035)
+(0.0030 -0.0675 0.1035)
+(0.0060 -0.0675 0.1035)
+(-0.0060 -0.0645 0.1035)
+(-0.0030 -0.0645 0.1035)
+(0.0000 -0.0645 0.1035)
+(0.0030 -0.0645 0.1035)
+(0.0060 -0.0645 0.1035)
+(-0.0060 -0.0615 0.1035)
+(-0.0030 -0.0615 0.1035)
+(0.0000 -0.0615 0.1035)
+(0.0030 -0.0615 0.1035)
+(0.0060 -0.0615 0.1035)
+(-0.0060 -0.0585 0.1035)
+(-0.0030 -0.0585 0.1035)
+(0.0000 -0.0585 0.1035)
+(0.0030 -0.0585 0.1035)
+(0.0060 -0.0585 0.1035)
+(-0.0060 -0.0555 0.1035)
+(-0.0030 -0.0555 0.1035)
+(0.0000 -0.0555 0.1035)
+(0.0030 -0.0555 0.1035)
+(0.0060 -0.0555 0.1035)
+(-0.0060 -0.0525 0.1035)
+(-0.0030 -0.0525 0.1035)
+(0.0000 -0.0525 0.1035)
+(0.0030 -0.0525 0.1035)
+(0.0060 -0.0525 0.1035)
+(-0.0060 -0.0495 0.1035)
+(-0.0030 -0.0495 0.1035)
+(0.0000 -0.0495 0.1035)
+(0.0030 -0.0495 0.1035)
+(0.0060 -0.0495 0.1035)
+(-0.0060 -0.0465 0.1035)
+(-0.0030 -0.0465 0.1035)
+(0.0000 -0.0465 0.1035)
+(0.0030 -0.0465 0.1035)
+(0.0060 -0.0465 0.1035)
+(-0.0060 -0.0435 0.1035)
+(-0.0030 -0.0435 0.1035)
+(0.0000 -0.0435 0.1035)
+(0.0030 -0.0435 0.1035)
+(0.0060 -0.0435 0.1035)
+(-0.0060 -0.0405 0.1035)
+(-0.0030 -0.0405 0.1035)
+(0.0000 -0.0405 0.1035)
+(0.0030 -0.0405 0.1035)
+(0.0060 -0.0405 0.1035)
+(-0.0060 -0.0375 0.1035)
+(-0.0030 -0.0375 0.1035)
+(0.0000 -0.0375 0.1035)
+(0.0030 -0.0375 0.1035)
+(0.0060 -0.0375 0.1035)
+(-0.0060 -0.0345 0.1035)
+(-0.0030 -0.0345 0.1035)
+(0.0000 -0.0345 0.1035)
+(0.0030 -0.0345 0.1035)
+(0.0060 -0.0345 0.1035)
+(-0.0060 -0.0315 0.1035)
+(-0.0030 -0.0315 0.1035)
+(0.0000 -0.0315 0.1035)
+(0.0030 -0.0315 0.1035)
+(0.0060 -0.0315 0.1035)
+(-0.0060 -0.0285 0.1035)
+(-0.0030 -0.0285 0.1035)
+(0.0000 -0.0285 0.1035)
+(0.0030 -0.0285 0.1035)
+(0.0060 -0.0285 0.1035)
+(-0.0060 -0.0255 0.1035)
+(-0.0030 -0.0255 0.1035)
+(0.0000 -0.0255 0.1035)
+(0.0030 -0.0255 0.1035)
+(0.0060 -0.0255 0.1035)
+(-0.0060 -0.0225 0.1035)
+(-0.0030 -0.0225 0.1035)
+(0.0000 -0.0225 0.1035)
+(0.0030 -0.0225 0.1035)
+(0.0060 -0.0225 0.1035)
+(-0.0060 -0.0195 0.1035)
+(-0.0030 -0.0195 0.1035)
+(0.0000 -0.0195 0.1035)
+(0.0030 -0.0195 0.1035)
+(0.0060 -0.0195 0.1035)
+(-0.0060 -0.0165 0.1035)
+(-0.0030 -0.0165 0.1035)
+(0.0000 -0.0165 0.1035)
+(0.0030 -0.0165 0.1035)
+(0.0060 -0.0165 0.1035)
+(-0.0060 -0.0135 0.1035)
+(-0.0030 -0.0135 0.1035)
+(0.0000 -0.0135 0.1035)
+(0.0030 -0.0135 0.1035)
+(0.0060 -0.0135 0.1035)
+(-0.0060 -0.0105 0.1035)
+(-0.0030 -0.0105 0.1035)
+(0.0000 -0.0105 0.1035)
+(0.0030 -0.0105 0.1035)
+(0.0060 -0.0105 0.1035)
+(-0.0060 -0.0075 0.1035)
+(-0.0030 -0.0075 0.1035)
+(0.0000 -0.0075 0.1035)
+(0.0030 -0.0075 0.1035)
+(0.0060 -0.0075 0.1035)
+(-0.0060 -0.0045 0.1035)
+(-0.0030 -0.0045 0.1035)
+(0.0000 -0.0045 0.1035)
+(0.0030 -0.0045 0.1035)
+(0.0060 -0.0045 0.1035)
+(-0.0060 -0.0015 0.1035)
+(-0.0030 -0.0015 0.1035)
+(0.0000 -0.0015 0.1035)
+(0.0030 -0.0015 0.1035)
+(0.0060 -0.0015 0.1035)
+(-0.0060 0.0015 0.1035)
+(-0.0030 0.0015 0.1035)
+(0.0000 0.0015 0.1035)
+(0.0030 0.0015 0.1035)
+(0.0060 0.0015 0.1035)
+(-0.0060 0.0045 0.1035)
+(-0.0030 0.0045 0.1035)
+(0.0000 0.0045 0.1035)
+(0.0030 0.0045 0.1035)
+(0.0060 0.0045 0.1035)
+(-0.0060 0.0075 0.1035)
+(-0.0030 0.0075 0.1035)
+(0.0000 0.0075 0.1035)
+(0.0030 0.0075 0.1035)
+(0.0060 0.0075 0.1035)
+(-0.0060 0.0105 0.1035)
+(-0.0030 0.0105 0.1035)
+(0.0000 0.0105 0.1035)
+(0.0030 0.0105 0.1035)
+(0.0060 0.0105 0.1035)
+(-0.0060 0.0135 0.1035)
+(-0.0030 0.0135 0.1035)
+(0.0000 0.0135 0.1035)
+(0.0030 0.0135 0.1035)
+(0.0060 0.0135 0.1035)
+(-0.0060 0.0165 0.1035)
+(-0.0030 0.0165 0.1035)
+(0.0000 0.0165 0.1035)
+(0.0030 0.0165 0.1035)
+(0.0060 0.0165 0.1035)
+(-0.0060 0.0195 0.1035)
+(-0.0030 0.0195 0.1035)
+(0.0000 0.0195 0.1035)
+(0.0030 0.0195 0.1035)
+(0.0060 0.0195 0.1035)
+(-0.0060 0.0225 0.1035)
+(-0.0030 0.0225 0.1035)
+(0.0000 0.0225 0.1035)
+(0.0030 0.0225 0.1035)
+(0.0060 0.0225 0.1035)
+(-0.0060 0.0255 0.1035)
+(-0.0030 0.0255 0.1035)
+(0.0000 0.0255 0.1035)
+(0.0030 0.0255 0.1035)
+(0.0060 0.0255 0.1035)
+(-0.0060 0.0285 0.1035)
+(-0.0030 0.0285 0.1035)
+(0.0000 0.0285 0.1035)
+(0.0030 0.0285 0.1035)
+(0.0060 0.0285 0.1035)
+(-0.0060 0.0315 0.1035)
+(-0.0030 0.0315 0.1035)
+(0.0000 0.0315 0.1035)
+(0.0030 0.0315 0.1035)
+(0.0060 0.0315 0.1035)
+(-0.0060 0.0345 0.1035)
+(-0.0030 0.0345 0.1035)
+(0.0000 0.0345 0.1035)
+(0.0030 0.0345 0.1035)
+(0.0060 0.0345 0.1035)
+(-0.0060 0.0375 0.1035)
+(-0.0030 0.0375 0.1035)
+(0.0000 0.0375 0.1035)
+(0.0030 0.0375 0.1035)
+(0.0060 0.0375 0.1035)
+(-0.0060 0.0405 0.1035)
+(-0.0030 0.0405 0.1035)
+(0.0000 0.0405 0.1035)
+(0.0030 0.0405 0.1035)
+(0.0060 0.0405 0.1035)
+(-0.0060 0.0435 0.1035)
+(-0.0030 0.0435 0.1035)
+(0.0000 0.0435 0.1035)
+(0.0030 0.0435 0.1035)
+(0.0060 0.0435 0.1035)
+(-0.0060 0.0465 0.1035)
+(-0.0030 0.0465 0.1035)
+(0.0000 0.0465 0.1035)
+(0.0030 0.0465 0.1035)
+(0.0060 0.0465 0.1035)
+(-0.0060 0.0495 0.1035)
+(-0.0030 0.0495 0.1035)
+(0.0000 0.0495 0.1035)
+(0.0030 0.0495 0.1035)
+(0.0060 0.0495 0.1035)
+(-0.0060 0.0525 0.1035)
+(-0.0030 0.0525 0.1035)
+(0.0000 0.0525 0.1035)
+(0.0030 0.0525 0.1035)
+(0.0060 0.0525 0.1035)
+(-0.0060 0.0555 0.1035)
+(-0.0030 0.0555 0.1035)
+(0.0000 0.0555 0.1035)
+(0.0030 0.0555 0.1035)
+(0.0060 0.0555 0.1035)
+(-0.0060 0.0585 0.1035)
+(-0.0030 0.0585 0.1035)
+(0.0000 0.0585 0.1035)
+(0.0030 0.0585 0.1035)
+(0.0060 0.0585 0.1035)
+(-0.0060 0.0615 0.1035)
+(-0.0030 0.0615 0.1035)
+(0.0000 0.0615 0.1035)
+(0.0030 0.0615 0.1035)
+(0.0060 0.0615 0.1035)
+(-0.0060 0.0645 0.1035)
+(-0.0030 0.0645 0.1035)
+(0.0000 0.0645 0.1035)
+(0.0030 0.0645 0.1035)
+(0.0060 0.0645 0.1035)
+(-0.0060 0.0675 0.1035)
+(-0.0030 0.0675 0.1035)
+(0.0000 0.0675 0.1035)
+(0.0030 0.0675 0.1035)
+(0.0060 0.0675 0.1035)
+(-0.0060 0.0705 0.1035)
+(-0.0030 0.0705 0.1035)
+(0.0000 0.0705 0.1035)
+(0.0030 0.0705 0.1035)
+(0.0060 0.0705 0.1035)
+(-0.0060 0.0735 0.1035)
+(-0.0030 0.0735 0.1035)
+(0.0000 0.0735 0.1035)
+(0.0030 0.0735 0.1035)
+(0.0060 0.0735 0.1035)
+(-0.0060 -0.0735 0.1065)
+(-0.0030 -0.0735 0.1065)
+(0.0000 -0.0735 0.1065)
+(0.0030 -0.0735 0.1065)
+(0.0060 -0.0735 0.1065)
+(-0.0060 -0.0705 0.1065)
+(-0.0030 -0.0705 0.1065)
+(0.0000 -0.0705 0.1065)
+(0.0030 -0.0705 0.1065)
+(0.0060 -0.0705 0.1065)
+(-0.0060 -0.0675 0.1065)
+(-0.0030 -0.0675 0.1065)
+(0.0000 -0.0675 0.1065)
+(0.0030 -0.0675 0.1065)
+(0.0060 -0.0675 0.1065)
+(-0.0060 -0.0645 0.1065)
+(-0.0030 -0.0645 0.1065)
+(0.0000 -0.0645 0.1065)
+(0.0030 -0.0645 0.1065)
+(0.0060 -0.0645 0.1065)
+(-0.0060 -0.0615 0.1065)
+(-0.0030 -0.0615 0.1065)
+(0.0000 -0.0615 0.1065)
+(0.0030 -0.0615 0.1065)
+(0.0060 -0.0615 0.1065)
+(-0.0060 -0.0585 0.1065)
+(-0.0030 -0.0585 0.1065)
+(0.0000 -0.0585 0.1065)
+(0.0030 -0.0585 0.1065)
+(0.0060 -0.0585 0.1065)
+(-0.0060 -0.0555 0.1065)
+(-0.0030 -0.0555 0.1065)
+(0.0000 -0.0555 0.1065)
+(0.0030 -0.0555 0.1065)
+(0.0060 -0.0555 0.1065)
+(-0.0060 -0.0525 0.1065)
+(-0.0030 -0.0525 0.1065)
+(0.0000 -0.0525 0.1065)
+(0.0030 -0.0525 0.1065)
+(0.0060 -0.0525 0.1065)
+(-0.0060 -0.0495 0.1065)
+(-0.0030 -0.0495 0.1065)
+(0.0000 -0.0495 0.1065)
+(0.0030 -0.0495 0.1065)
+(0.0060 -0.0495 0.1065)
+(-0.0060 -0.0465 0.1065)
+(-0.0030 -0.0465 0.1065)
+(0.0000 -0.0465 0.1065)
+(0.0030 -0.0465 0.1065)
+(0.0060 -0.0465 0.1065)
+(-0.0060 -0.0435 0.1065)
+(-0.0030 -0.0435 0.1065)
+(0.0000 -0.0435 0.1065)
+(0.0030 -0.0435 0.1065)
+(0.0060 -0.0435 0.1065)
+(-0.0060 -0.0405 0.1065)
+(-0.0030 -0.0405 0.1065)
+(0.0000 -0.0405 0.1065)
+(0.0030 -0.0405 0.1065)
+(0.0060 -0.0405 0.1065)
+(-0.0060 -0.0375 0.1065)
+(-0.0030 -0.0375 0.1065)
+(0.0000 -0.0375 0.1065)
+(0.0030 -0.0375 0.1065)
+(0.0060 -0.0375 0.1065)
+(-0.0060 -0.0345 0.1065)
+(-0.0030 -0.0345 0.1065)
+(0.0000 -0.0345 0.1065)
+(0.0030 -0.0345 0.1065)
+(0.0060 -0.0345 0.1065)
+(-0.0060 -0.0315 0.1065)
+(-0.0030 -0.0315 0.1065)
+(0.0000 -0.0315 0.1065)
+(0.0030 -0.0315 0.1065)
+(0.0060 -0.0315 0.1065)
+(-0.0060 -0.0285 0.1065)
+(-0.0030 -0.0285 0.1065)
+(0.0000 -0.0285 0.1065)
+(0.0030 -0.0285 0.1065)
+(0.0060 -0.0285 0.1065)
+(-0.0060 -0.0255 0.1065)
+(-0.0030 -0.0255 0.1065)
+(0.0000 -0.0255 0.1065)
+(0.0030 -0.0255 0.1065)
+(0.0060 -0.0255 0.1065)
+(-0.0060 -0.0225 0.1065)
+(-0.0030 -0.0225 0.1065)
+(0.0000 -0.0225 0.1065)
+(0.0030 -0.0225 0.1065)
+(0.0060 -0.0225 0.1065)
+(-0.0060 -0.0195 0.1065)
+(-0.0030 -0.0195 0.1065)
+(0.0000 -0.0195 0.1065)
+(0.0030 -0.0195 0.1065)
+(0.0060 -0.0195 0.1065)
+(-0.0060 -0.0165 0.1065)
+(-0.0030 -0.0165 0.1065)
+(0.0000 -0.0165 0.1065)
+(0.0030 -0.0165 0.1065)
+(0.0060 -0.0165 0.1065)
+(-0.0060 -0.0135 0.1065)
+(-0.0030 -0.0135 0.1065)
+(0.0000 -0.0135 0.1065)
+(0.0030 -0.0135 0.1065)
+(0.0060 -0.0135 0.1065)
+(-0.0060 -0.0105 0.1065)
+(-0.0030 -0.0105 0.1065)
+(0.0000 -0.0105 0.1065)
+(0.0030 -0.0105 0.1065)
+(0.0060 -0.0105 0.1065)
+(-0.0060 -0.0075 0.1065)
+(-0.0030 -0.0075 0.1065)
+(0.0000 -0.0075 0.1065)
+(0.0030 -0.0075 0.1065)
+(0.0060 -0.0075 0.1065)
+(-0.0060 -0.0045 0.1065)
+(-0.0030 -0.0045 0.1065)
+(0.0000 -0.0045 0.1065)
+(0.0030 -0.0045 0.1065)
+(0.0060 -0.0045 0.1065)
+(-0.0060 -0.0015 0.1065)
+(-0.0030 -0.0015 0.1065)
+(0.0000 -0.0015 0.1065)
+(0.0030 -0.0015 0.1065)
+(0.0060 -0.0015 0.1065)
+(-0.0060 0.0015 0.1065)
+(-0.0030 0.0015 0.1065)
+(0.0000 0.0015 0.1065)
+(0.0030 0.0015 0.1065)
+(0.0060 0.0015 0.1065)
+(-0.0060 0.0045 0.1065)
+(-0.0030 0.0045 0.1065)
+(0.0000 0.0045 0.1065)
+(0.0030 0.0045 0.1065)
+(0.0060 0.0045 0.1065)
+(-0.0060 0.0075 0.1065)
+(-0.0030 0.0075 0.1065)
+(0.0000 0.0075 0.1065)
+(0.0030 0.0075 0.1065)
+(0.0060 0.0075 0.1065)
+(-0.0060 0.0105 0.1065)
+(-0.0030 0.0105 0.1065)
+(0.0000 0.0105 0.1065)
+(0.0030 0.0105 0.1065)
+(0.0060 0.0105 0.1065)
+(-0.0060 0.0135 0.1065)
+(-0.0030 0.0135 0.1065)
+(0.0000 0.0135 0.1065)
+(0.0030 0.0135 0.1065)
+(0.0060 0.0135 0.1065)
+(-0.0060 0.0165 0.1065)
+(-0.0030 0.0165 0.1065)
+(0.0000 0.0165 0.1065)
+(0.0030 0.0165 0.1065)
+(0.0060 0.0165 0.1065)
+(-0.0060 0.0195 0.1065)
+(-0.0030 0.0195 0.1065)
+(0.0000 0.0195 0.1065)
+(0.0030 0.0195 0.1065)
+(0.0060 0.0195 0.1065)
+(-0.0060 0.0225 0.1065)
+(-0.0030 0.0225 0.1065)
+(0.0000 0.0225 0.1065)
+(0.0030 0.0225 0.1065)
+(0.0060 0.0225 0.1065)
+(-0.0060 0.0255 0.1065)
+(-0.0030 0.0255 0.1065)
+(0.0000 0.0255 0.1065)
+(0.0030 0.0255 0.1065)
+(0.0060 0.0255 0.1065)
+(-0.0060 0.0285 0.1065)
+(-0.0030 0.0285 0.1065)
+(0.0000 0.0285 0.1065)
+(0.0030 0.0285 0.1065)
+(0.0060 0.0285 0.1065)
+(-0.0060 0.0315 0.1065)
+(-0.0030 0.0315 0.1065)
+(0.0000 0.0315 0.1065)
+(0.0030 0.0315 0.1065)
+(0.0060 0.0315 0.1065)
+(-0.0060 0.0345 0.1065)
+(-0.0030 0.0345 0.1065)
+(0.0000 0.0345 0.1065)
+(0.0030 0.0345 0.1065)
+(0.0060 0.0345 0.1065)
+(-0.0060 0.0375 0.1065)
+(-0.0030 0.0375 0.1065)
+(0.0000 0.0375 0.1065)
+(0.0030 0.0375 0.1065)
+(0.0060 0.0375 0.1065)
+(-0.0060 0.0405 0.1065)
+(-0.0030 0.0405 0.1065)
+(0.0000 0.0405 0.1065)
+(0.0030 0.0405 0.1065)
+(0.0060 0.0405 0.1065)
+(-0.0060 0.0435 0.1065)
+(-0.0030 0.0435 0.1065)
+(0.0000 0.0435 0.1065)
+(0.0030 0.0435 0.1065)
+(0.0060 0.0435 0.1065)
+(-0.0060 0.0465 0.1065)
+(-0.0030 0.0465 0.1065)
+(0.0000 0.0465 0.1065)
+(0.0030 0.0465 0.1065)
+(0.0060 0.0465 0.1065)
+(-0.0060 0.0495 0.1065)
+(-0.0030 0.0495 0.1065)
+(0.0000 0.0495 0.1065)
+(0.0030 0.0495 0.1065)
+(0.0060 0.0495 0.1065)
+(-0.0060 0.0525 0.1065)
+(-0.0030 0.0525 0.1065)
+(0.0000 0.0525 0.1065)
+(0.0030 0.0525 0.1065)
+(0.0060 0.0525 0.1065)
+(-0.0060 0.0555 0.1065)
+(-0.0030 0.0555 0.1065)
+(0.0000 0.0555 0.1065)
+(0.0030 0.0555 0.1065)
+(0.0060 0.0555 0.1065)
+(-0.0060 0.0585 0.1065)
+(-0.0030 0.0585 0.1065)
+(0.0000 0.0585 0.1065)
+(0.0030 0.0585 0.1065)
+(0.0060 0.0585 0.1065)
+(-0.0060 0.0615 0.1065)
+(-0.0030 0.0615 0.1065)
+(0.0000 0.0615 0.1065)
+(0.0030 0.0615 0.1065)
+(0.0060 0.0615 0.1065)
+(-0.0060 0.0645 0.1065)
+(-0.0030 0.0645 0.1065)
+(0.0000 0.0645 0.1065)
+(0.0030 0.0645 0.1065)
+(0.0060 0.0645 0.1065)
+(-0.0060 0.0675 0.1065)
+(-0.0030 0.0675 0.1065)
+(0.0000 0.0675 0.1065)
+(0.0030 0.0675 0.1065)
+(0.0060 0.0675 0.1065)
+(-0.0060 0.0705 0.1065)
+(-0.0030 0.0705 0.1065)
+(0.0000 0.0705 0.1065)
+(0.0030 0.0705 0.1065)
+(0.0060 0.0705 0.1065)
+(-0.0060 0.0735 0.1065)
+(-0.0030 0.0735 0.1065)
+(0.0000 0.0735 0.1065)
+(0.0030 0.0735 0.1065)
+(0.0060 0.0735 0.1065)
+(-0.0060 -0.0735 0.1095)
+(-0.0030 -0.0735 0.1095)
+(0.0000 -0.0735 0.1095)
+(0.0030 -0.0735 0.1095)
+(0.0060 -0.0735 0.1095)
+(-0.0060 -0.0705 0.1095)
+(-0.0030 -0.0705 0.1095)
+(0.0000 -0.0705 0.1095)
+(0.0030 -0.0705 0.1095)
+(0.0060 -0.0705 0.1095)
+(-0.0060 -0.0675 0.1095)
+(-0.0030 -0.0675 0.1095)
+(0.0000 -0.0675 0.1095)
+(0.0030 -0.0675 0.1095)
+(0.0060 -0.0675 0.1095)
+(-0.0060 -0.0645 0.1095)
+(-0.0030 -0.0645 0.1095)
+(0.0000 -0.0645 0.1095)
+(0.0030 -0.0645 0.1095)
+(0.0060 -0.0645 0.1095)
+(-0.0060 -0.0615 0.1095)
+(-0.0030 -0.0615 0.1095)
+(0.0000 -0.0615 0.1095)
+(0.0030 -0.0615 0.1095)
+(0.0060 -0.0615 0.1095)
+(-0.0060 -0.0585 0.1095)
+(-0.0030 -0.0585 0.1095)
+(0.0000 -0.0585 0.1095)
+(0.0030 -0.0585 0.1095)
+(0.0060 -0.0585 0.1095)
+(-0.0060 -0.0555 0.1095)
+(-0.0030 -0.0555 0.1095)
+(0.0000 -0.0555 0.1095)
+(0.0030 -0.0555 0.1095)
+(0.0060 -0.0555 0.1095)
+(-0.0060 -0.0525 0.1095)
+(-0.0030 -0.0525 0.1095)
+(0.0000 -0.0525 0.1095)
+(0.0030 -0.0525 0.1095)
+(0.0060 -0.0525 0.1095)
+(-0.0060 -0.0495 0.1095)
+(-0.0030 -0.0495 0.1095)
+(0.0000 -0.0495 0.1095)
+(0.0030 -0.0495 0.1095)
+(0.0060 -0.0495 0.1095)
+(-0.0060 -0.0465 0.1095)
+(-0.0030 -0.0465 0.1095)
+(0.0000 -0.0465 0.1095)
+(0.0030 -0.0465 0.1095)
+(0.0060 -0.0465 0.1095)
+(-0.0060 -0.0435 0.1095)
+(-0.0030 -0.0435 0.1095)
+(0.0000 -0.0435 0.1095)
+(0.0030 -0.0435 0.1095)
+(0.0060 -0.0435 0.1095)
+(-0.0060 -0.0405 0.1095)
+(-0.0030 -0.0405 0.1095)
+(0.0000 -0.0405 0.1095)
+(0.0030 -0.0405 0.1095)
+(0.0060 -0.0405 0.1095)
+(-0.0060 -0.0375 0.1095)
+(-0.0030 -0.0375 0.1095)
+(0.0000 -0.0375 0.1095)
+(0.0030 -0.0375 0.1095)
+(0.0060 -0.0375 0.1095)
+(-0.0060 -0.0345 0.1095)
+(-0.0030 -0.0345 0.1095)
+(0.0000 -0.0345 0.1095)
+(0.0030 -0.0345 0.1095)
+(0.0060 -0.0345 0.1095)
+(-0.0060 -0.0315 0.1095)
+(-0.0030 -0.0315 0.1095)
+(0.0000 -0.0315 0.1095)
+(0.0030 -0.0315 0.1095)
+(0.0060 -0.0315 0.1095)
+(-0.0060 -0.0285 0.1095)
+(-0.0030 -0.0285 0.1095)
+(0.0000 -0.0285 0.1095)
+(0.0030 -0.0285 0.1095)
+(0.0060 -0.0285 0.1095)
+(-0.0060 -0.0255 0.1095)
+(-0.0030 -0.0255 0.1095)
+(0.0000 -0.0255 0.1095)
+(0.0030 -0.0255 0.1095)
+(0.0060 -0.0255 0.1095)
+(-0.0060 -0.0225 0.1095)
+(-0.0030 -0.0225 0.1095)
+(0.0000 -0.0225 0.1095)
+(0.0030 -0.0225 0.1095)
+(0.0060 -0.0225 0.1095)
+(-0.0060 -0.0195 0.1095)
+(-0.0030 -0.0195 0.1095)
+(0.0000 -0.0195 0.1095)
+(0.0030 -0.0195 0.1095)
+(0.0060 -0.0195 0.1095)
+(-0.0060 -0.0165 0.1095)
+(-0.0030 -0.0165 0.1095)
+(0.0000 -0.0165 0.1095)
+(0.0030 -0.0165 0.1095)
+(0.0060 -0.0165 0.1095)
+(-0.0060 -0.0135 0.1095)
+(-0.0030 -0.0135 0.1095)
+(0.0000 -0.0135 0.1095)
+(0.0030 -0.0135 0.1095)
+(0.0060 -0.0135 0.1095)
+(-0.0060 -0.0105 0.1095)
+(-0.0030 -0.0105 0.1095)
+(0.0000 -0.0105 0.1095)
+(0.0030 -0.0105 0.1095)
+(0.0060 -0.0105 0.1095)
+(-0.0060 -0.0075 0.1095)
+(-0.0030 -0.0075 0.1095)
+(0.0000 -0.0075 0.1095)
+(0.0030 -0.0075 0.1095)
+(0.0060 -0.0075 0.1095)
+(-0.0060 -0.0045 0.1095)
+(-0.0030 -0.0045 0.1095)
+(0.0000 -0.0045 0.1095)
+(0.0030 -0.0045 0.1095)
+(0.0060 -0.0045 0.1095)
+(-0.0060 -0.0015 0.1095)
+(-0.0030 -0.0015 0.1095)
+(0.0000 -0.0015 0.1095)
+(0.0030 -0.0015 0.1095)
+(0.0060 -0.0015 0.1095)
+(-0.0060 0.0015 0.1095)
+(-0.0030 0.0015 0.1095)
+(0.0000 0.0015 0.1095)
+(0.0030 0.0015 0.1095)
+(0.0060 0.0015 0.1095)
+(-0.0060 0.0045 0.1095)
+(-0.0030 0.0045 0.1095)
+(0.0000 0.0045 0.1095)
+(0.0030 0.0045 0.1095)
+(0.0060 0.0045 0.1095)
+(-0.0060 0.0075 0.1095)
+(-0.0030 0.0075 0.1095)
+(0.0000 0.0075 0.1095)
+(0.0030 0.0075 0.1095)
+(0.0060 0.0075 0.1095)
+(-0.0060 0.0105 0.1095)
+(-0.0030 0.0105 0.1095)
+(0.0000 0.0105 0.1095)
+(0.0030 0.0105 0.1095)
+(0.0060 0.0105 0.1095)
+(-0.0060 0.0135 0.1095)
+(-0.0030 0.0135 0.1095)
+(0.0000 0.0135 0.1095)
+(0.0030 0.0135 0.1095)
+(0.0060 0.0135 0.1095)
+(-0.0060 0.0165 0.1095)
+(-0.0030 0.0165 0.1095)
+(0.0000 0.0165 0.1095)
+(0.0030 0.0165 0.1095)
+(0.0060 0.0165 0.1095)
+(-0.0060 0.0195 0.1095)
+(-0.0030 0.0195 0.1095)
+(0.0000 0.0195 0.1095)
+(0.0030 0.0195 0.1095)
+(0.0060 0.0195 0.1095)
+(-0.0060 0.0225 0.1095)
+(-0.0030 0.0225 0.1095)
+(0.0000 0.0225 0.1095)
+(0.0030 0.0225 0.1095)
+(0.0060 0.0225 0.1095)
+(-0.0060 0.0255 0.1095)
+(-0.0030 0.0255 0.1095)
+(0.0000 0.0255 0.1095)
+(0.0030 0.0255 0.1095)
+(0.0060 0.0255 0.1095)
+(-0.0060 0.0285 0.1095)
+(-0.0030 0.0285 0.1095)
+(0.0000 0.0285 0.1095)
+(0.0030 0.0285 0.1095)
+(0.0060 0.0285 0.1095)
+(-0.0060 0.0315 0.1095)
+(-0.0030 0.0315 0.1095)
+(0.0000 0.0315 0.1095)
+(0.0030 0.0315 0.1095)
+(0.0060 0.0315 0.1095)
+(-0.0060 0.0345 0.1095)
+(-0.0030 0.0345 0.1095)
+(0.0000 0.0345 0.1095)
+(0.0030 0.0345 0.1095)
+(0.0060 0.0345 0.1095)
+(-0.0060 0.0375 0.1095)
+(-0.0030 0.0375 0.1095)
+(0.0000 0.0375 0.1095)
+(0.0030 0.0375 0.1095)
+(0.0060 0.0375 0.1095)
+(-0.0060 0.0405 0.1095)
+(-0.0030 0.0405 0.1095)
+(0.0000 0.0405 0.1095)
+(0.0030 0.0405 0.1095)
+(0.0060 0.0405 0.1095)
+(-0.0060 0.0435 0.1095)
+(-0.0030 0.0435 0.1095)
+(0.0000 0.0435 0.1095)
+(0.0030 0.0435 0.1095)
+(0.0060 0.0435 0.1095)
+(-0.0060 0.0465 0.1095)
+(-0.0030 0.0465 0.1095)
+(0.0000 0.0465 0.1095)
+(0.0030 0.0465 0.1095)
+(0.0060 0.0465 0.1095)
+(-0.0060 0.0495 0.1095)
+(-0.0030 0.0495 0.1095)
+(0.0000 0.0495 0.1095)
+(0.0030 0.0495 0.1095)
+(0.0060 0.0495 0.1095)
+(-0.0060 0.0525 0.1095)
+(-0.0030 0.0525 0.1095)
+(0.0000 0.0525 0.1095)
+(0.0030 0.0525 0.1095)
+(0.0060 0.0525 0.1095)
+(-0.0060 0.0555 0.1095)
+(-0.0030 0.0555 0.1095)
+(0.0000 0.0555 0.1095)
+(0.0030 0.0555 0.1095)
+(0.0060 0.0555 0.1095)
+(-0.0060 0.0585 0.1095)
+(-0.0030 0.0585 0.1095)
+(0.0000 0.0585 0.1095)
+(0.0030 0.0585 0.1095)
+(0.0060 0.0585 0.1095)
+(-0.0060 0.0615 0.1095)
+(-0.0030 0.0615 0.1095)
+(0.0000 0.0615 0.1095)
+(0.0030 0.0615 0.1095)
+(0.0060 0.0615 0.1095)
+(-0.0060 0.0645 0.1095)
+(-0.0030 0.0645 0.1095)
+(0.0000 0.0645 0.1095)
+(0.0030 0.0645 0.1095)
+(0.0060 0.0645 0.1095)
+(-0.0060 0.0675 0.1095)
+(-0.0030 0.0675 0.1095)
+(0.0000 0.0675 0.1095)
+(0.0030 0.0675 0.1095)
+(0.0060 0.0675 0.1095)
+(-0.0060 0.0705 0.1095)
+(-0.0030 0.0705 0.1095)
+(0.0000 0.0705 0.1095)
+(0.0030 0.0705 0.1095)
+(0.0060 0.0705 0.1095)
+(-0.0060 0.0735 0.1095)
+(-0.0030 0.0735 0.1095)
+(0.0000 0.0735 0.1095)
+(0.0030 0.0735 0.1095)
+(0.0060 0.0735 0.1095)
+(-0.0060 -0.0735 0.1125)
+(-0.0030 -0.0735 0.1125)
+(0.0000 -0.0735 0.1125)
+(0.0030 -0.0735 0.1125)
+(0.0060 -0.0735 0.1125)
+(-0.0060 -0.0705 0.1125)
+(-0.0030 -0.0705 0.1125)
+(0.0000 -0.0705 0.1125)
+(0.0030 -0.0705 0.1125)
+(0.0060 -0.0705 0.1125)
+(-0.0060 -0.0675 0.1125)
+(-0.0030 -0.0675 0.1125)
+(0.0000 -0.0675 0.1125)
+(0.0030 -0.0675 0.1125)
+(0.0060 -0.0675 0.1125)
+(-0.0060 -0.0645 0.1125)
+(-0.0030 -0.0645 0.1125)
+(0.0000 -0.0645 0.1125)
+(0.0030 -0.0645 0.1125)
+(0.0060 -0.0645 0.1125)
+(-0.0060 -0.0615 0.1125)
+(-0.0030 -0.0615 0.1125)
+(0.0000 -0.0615 0.1125)
+(0.0030 -0.0615 0.1125)
+(0.0060 -0.0615 0.1125)
+(-0.0060 -0.0585 0.1125)
+(-0.0030 -0.0585 0.1125)
+(0.0000 -0.0585 0.1125)
+(0.0030 -0.0585 0.1125)
+(0.0060 -0.0585 0.1125)
+(-0.0060 -0.0555 0.1125)
+(-0.0030 -0.0555 0.1125)
+(0.0000 -0.0555 0.1125)
+(0.0030 -0.0555 0.1125)
+(0.0060 -0.0555 0.1125)
+(-0.0060 -0.0525 0.1125)
+(-0.0030 -0.0525 0.1125)
+(0.0000 -0.0525 0.1125)
+(0.0030 -0.0525 0.1125)
+(0.0060 -0.0525 0.1125)
+(-0.0060 -0.0495 0.1125)
+(-0.0030 -0.0495 0.1125)
+(0.0000 -0.0495 0.1125)
+(0.0030 -0.0495 0.1125)
+(0.0060 -0.0495 0.1125)
+(-0.0060 -0.0465 0.1125)
+(-0.0030 -0.0465 0.1125)
+(0.0000 -0.0465 0.1125)
+(0.0030 -0.0465 0.1125)
+(0.0060 -0.0465 0.1125)
+(-0.0060 -0.0435 0.1125)
+(-0.0030 -0.0435 0.1125)
+(0.0000 -0.0435 0.1125)
+(0.0030 -0.0435 0.1125)
+(0.0060 -0.0435 0.1125)
+(-0.0060 -0.0405 0.1125)
+(-0.0030 -0.0405 0.1125)
+(0.0000 -0.0405 0.1125)
+(0.0030 -0.0405 0.1125)
+(0.0060 -0.0405 0.1125)
+(-0.0060 -0.0375 0.1125)
+(-0.0030 -0.0375 0.1125)
+(0.0000 -0.0375 0.1125)
+(0.0030 -0.0375 0.1125)
+(0.0060 -0.0375 0.1125)
+(-0.0060 -0.0345 0.1125)
+(-0.0030 -0.0345 0.1125)
+(0.0000 -0.0345 0.1125)
+(0.0030 -0.0345 0.1125)
+(0.0060 -0.0345 0.1125)
+(-0.0060 -0.0315 0.1125)
+(-0.0030 -0.0315 0.1125)
+(0.0000 -0.0315 0.1125)
+(0.0030 -0.0315 0.1125)
+(0.0060 -0.0315 0.1125)
+(-0.0060 -0.0285 0.1125)
+(-0.0030 -0.0285 0.1125)
+(0.0000 -0.0285 0.1125)
+(0.0030 -0.0285 0.1125)
+(0.0060 -0.0285 0.1125)
+(-0.0060 -0.0255 0.1125)
+(-0.0030 -0.0255 0.1125)
+(0.0000 -0.0255 0.1125)
+(0.0030 -0.0255 0.1125)
+(0.0060 -0.0255 0.1125)
+(-0.0060 -0.0225 0.1125)
+(-0.0030 -0.0225 0.1125)
+(0.0000 -0.0225 0.1125)
+(0.0030 -0.0225 0.1125)
+(0.0060 -0.0225 0.1125)
+(-0.0060 -0.0195 0.1125)
+(-0.0030 -0.0195 0.1125)
+(0.0000 -0.0195 0.1125)
+(0.0030 -0.0195 0.1125)
+(0.0060 -0.0195 0.1125)
+(-0.0060 -0.0165 0.1125)
+(-0.0030 -0.0165 0.1125)
+(0.0000 -0.0165 0.1125)
+(0.0030 -0.0165 0.1125)
+(0.0060 -0.0165 0.1125)
+(-0.0060 -0.0135 0.1125)
+(-0.0030 -0.0135 0.1125)
+(0.0000 -0.0135 0.1125)
+(0.0030 -0.0135 0.1125)
+(0.0060 -0.0135 0.1125)
+(-0.0060 -0.0105 0.1125)
+(-0.0030 -0.0105 0.1125)
+(0.0000 -0.0105 0.1125)
+(0.0030 -0.0105 0.1125)
+(0.0060 -0.0105 0.1125)
+(-0.0060 -0.0075 0.1125)
+(-0.0030 -0.0075 0.1125)
+(0.0000 -0.0075 0.1125)
+(0.0030 -0.0075 0.1125)
+(0.0060 -0.0075 0.1125)
+(-0.0060 -0.0045 0.1125)
+(-0.0030 -0.0045 0.1125)
+(0.0000 -0.0045 0.1125)
+(0.0030 -0.0045 0.1125)
+(0.0060 -0.0045 0.1125)
+(-0.0060 -0.0015 0.1125)
+(-0.0030 -0.0015 0.1125)
+(0.0000 -0.0015 0.1125)
+(0.0030 -0.0015 0.1125)
+(0.0060 -0.0015 0.1125)
+(-0.0060 0.0015 0.1125)
+(-0.0030 0.0015 0.1125)
+(0.0000 0.0015 0.1125)
+(0.0030 0.0015 0.1125)
+(0.0060 0.0015 0.1125)
+(-0.0060 0.0045 0.1125)
+(-0.0030 0.0045 0.1125)
+(0.0000 0.0045 0.1125)
+(0.0030 0.0045 0.1125)
+(0.0060 0.0045 0.1125)
+(-0.0060 0.0075 0.1125)
+(-0.0030 0.0075 0.1125)
+(0.0000 0.0075 0.1125)
+(0.0030 0.0075 0.1125)
+(0.0060 0.0075 0.1125)
+(-0.0060 0.0105 0.1125)
+(-0.0030 0.0105 0.1125)
+(0.0000 0.0105 0.1125)
+(0.0030 0.0105 0.1125)
+(0.0060 0.0105 0.1125)
+(-0.0060 0.0135 0.1125)
+(-0.0030 0.0135 0.1125)
+(0.0000 0.0135 0.1125)
+(0.0030 0.0135 0.1125)
+(0.0060 0.0135 0.1125)
+(-0.0060 0.0165 0.1125)
+(-0.0030 0.0165 0.1125)
+(0.0000 0.0165 0.1125)
+(0.0030 0.0165 0.1125)
+(0.0060 0.0165 0.1125)
+(-0.0060 0.0195 0.1125)
+(-0.0030 0.0195 0.1125)
+(0.0000 0.0195 0.1125)
+(0.0030 0.0195 0.1125)
+(0.0060 0.0195 0.1125)
+(-0.0060 0.0225 0.1125)
+(-0.0030 0.0225 0.1125)
+(0.0000 0.0225 0.1125)
+(0.0030 0.0225 0.1125)
+(0.0060 0.0225 0.1125)
+(-0.0060 0.0255 0.1125)
+(-0.0030 0.0255 0.1125)
+(0.0000 0.0255 0.1125)
+(0.0030 0.0255 0.1125)
+(0.0060 0.0255 0.1125)
+(-0.0060 0.0285 0.1125)
+(-0.0030 0.0285 0.1125)
+(0.0000 0.0285 0.1125)
+(0.0030 0.0285 0.1125)
+(0.0060 0.0285 0.1125)
+(-0.0060 0.0315 0.1125)
+(-0.0030 0.0315 0.1125)
+(0.0000 0.0315 0.1125)
+(0.0030 0.0315 0.1125)
+(0.0060 0.0315 0.1125)
+(-0.0060 0.0345 0.1125)
+(-0.0030 0.0345 0.1125)
+(0.0000 0.0345 0.1125)
+(0.0030 0.0345 0.1125)
+(0.0060 0.0345 0.1125)
+(-0.0060 0.0375 0.1125)
+(-0.0030 0.0375 0.1125)
+(0.0000 0.0375 0.1125)
+(0.0030 0.0375 0.1125)
+(0.0060 0.0375 0.1125)
+(-0.0060 0.0405 0.1125)
+(-0.0030 0.0405 0.1125)
+(0.0000 0.0405 0.1125)
+(0.0030 0.0405 0.1125)
+(0.0060 0.0405 0.1125)
+(-0.0060 0.0435 0.1125)
+(-0.0030 0.0435 0.1125)
+(0.0000 0.0435 0.1125)
+(0.0030 0.0435 0.1125)
+(0.0060 0.0435 0.1125)
+(-0.0060 0.0465 0.1125)
+(-0.0030 0.0465 0.1125)
+(0.0000 0.0465 0.1125)
+(0.0030 0.0465 0.1125)
+(0.0060 0.0465 0.1125)
+(-0.0060 0.0495 0.1125)
+(-0.0030 0.0495 0.1125)
+(0.0000 0.0495 0.1125)
+(0.0030 0.0495 0.1125)
+(0.0060 0.0495 0.1125)
+(-0.0060 0.0525 0.1125)
+(-0.0030 0.0525 0.1125)
+(0.0000 0.0525 0.1125)
+(0.0030 0.0525 0.1125)
+(0.0060 0.0525 0.1125)
+(-0.0060 0.0555 0.1125)
+(-0.0030 0.0555 0.1125)
+(0.0000 0.0555 0.1125)
+(0.0030 0.0555 0.1125)
+(0.0060 0.0555 0.1125)
+(-0.0060 0.0585 0.1125)
+(-0.0030 0.0585 0.1125)
+(0.0000 0.0585 0.1125)
+(0.0030 0.0585 0.1125)
+(0.0060 0.0585 0.1125)
+(-0.0060 0.0615 0.1125)
+(-0.0030 0.0615 0.1125)
+(0.0000 0.0615 0.1125)
+(0.0030 0.0615 0.1125)
+(0.0060 0.0615 0.1125)
+(-0.0060 0.0645 0.1125)
+(-0.0030 0.0645 0.1125)
+(0.0000 0.0645 0.1125)
+(0.0030 0.0645 0.1125)
+(0.0060 0.0645 0.1125)
+(-0.0060 0.0675 0.1125)
+(-0.0030 0.0675 0.1125)
+(0.0000 0.0675 0.1125)
+(0.0030 0.0675 0.1125)
+(0.0060 0.0675 0.1125)
+(-0.0060 0.0705 0.1125)
+(-0.0030 0.0705 0.1125)
+(0.0000 0.0705 0.1125)
+(0.0030 0.0705 0.1125)
+(0.0060 0.0705 0.1125)
+(-0.0060 0.0735 0.1125)
+(-0.0030 0.0735 0.1125)
+(0.0000 0.0735 0.1125)
+(0.0030 0.0735 0.1125)
+(0.0060 0.0735 0.1125)
+(-0.0060 -0.0735 0.1155)
+(-0.0030 -0.0735 0.1155)
+(0.0000 -0.0735 0.1155)
+(0.0030 -0.0735 0.1155)
+(0.0060 -0.0735 0.1155)
+(-0.0060 -0.0705 0.1155)
+(-0.0030 -0.0705 0.1155)
+(0.0000 -0.0705 0.1155)
+(0.0030 -0.0705 0.1155)
+(0.0060 -0.0705 0.1155)
+(-0.0060 -0.0675 0.1155)
+(-0.0030 -0.0675 0.1155)
+(0.0000 -0.0675 0.1155)
+(0.0030 -0.0675 0.1155)
+(0.0060 -0.0675 0.1155)
+(-0.0060 -0.0645 0.1155)
+(-0.0030 -0.0645 0.1155)
+(0.0000 -0.0645 0.1155)
+(0.0030 -0.0645 0.1155)
+(0.0060 -0.0645 0.1155)
+(-0.0060 -0.0615 0.1155)
+(-0.0030 -0.0615 0.1155)
+(0.0000 -0.0615 0.1155)
+(0.0030 -0.0615 0.1155)
+(0.0060 -0.0615 0.1155)
+(-0.0060 -0.0585 0.1155)
+(-0.0030 -0.0585 0.1155)
+(0.0000 -0.0585 0.1155)
+(0.0030 -0.0585 0.1155)
+(0.0060 -0.0585 0.1155)
+(-0.0060 -0.0555 0.1155)
+(-0.0030 -0.0555 0.1155)
+(0.0000 -0.0555 0.1155)
+(0.0030 -0.0555 0.1155)
+(0.0060 -0.0555 0.1155)
+(-0.0060 -0.0525 0.1155)
+(-0.0030 -0.0525 0.1155)
+(0.0000 -0.0525 0.1155)
+(0.0030 -0.0525 0.1155)
+(0.0060 -0.0525 0.1155)
+(-0.0060 -0.0495 0.1155)
+(-0.0030 -0.0495 0.1155)
+(0.0000 -0.0495 0.1155)
+(0.0030 -0.0495 0.1155)
+(0.0060 -0.0495 0.1155)
+(-0.0060 -0.0465 0.1155)
+(-0.0030 -0.0465 0.1155)
+(0.0000 -0.0465 0.1155)
+(0.0030 -0.0465 0.1155)
+(0.0060 -0.0465 0.1155)
+(-0.0060 -0.0435 0.1155)
+(-0.0030 -0.0435 0.1155)
+(0.0000 -0.0435 0.1155)
+(0.0030 -0.0435 0.1155)
+(0.0060 -0.0435 0.1155)
+(-0.0060 -0.0405 0.1155)
+(-0.0030 -0.0405 0.1155)
+(0.0000 -0.0405 0.1155)
+(0.0030 -0.0405 0.1155)
+(0.0060 -0.0405 0.1155)
+(-0.0060 -0.0375 0.1155)
+(-0.0030 -0.0375 0.1155)
+(0.0000 -0.0375 0.1155)
+(0.0030 -0.0375 0.1155)
+(0.0060 -0.0375 0.1155)
+(-0.0060 -0.0345 0.1155)
+(-0.0030 -0.0345 0.1155)
+(0.0000 -0.0345 0.1155)
+(0.0030 -0.0345 0.1155)
+(0.0060 -0.0345 0.1155)
+(-0.0060 -0.0315 0.1155)
+(-0.0030 -0.0315 0.1155)
+(0.0000 -0.0315 0.1155)
+(0.0030 -0.0315 0.1155)
+(0.0060 -0.0315 0.1155)
+(-0.0060 -0.0285 0.1155)
+(-0.0030 -0.0285 0.1155)
+(0.0000 -0.0285 0.1155)
+(0.0030 -0.0285 0.1155)
+(0.0060 -0.0285 0.1155)
+(-0.0060 -0.0255 0.1155)
+(-0.0030 -0.0255 0.1155)
+(0.0000 -0.0255 0.1155)
+(0.0030 -0.0255 0.1155)
+(0.0060 -0.0255 0.1155)
+(-0.0060 -0.0225 0.1155)
+(-0.0030 -0.0225 0.1155)
+(0.0000 -0.0225 0.1155)
+(0.0030 -0.0225 0.1155)
+(0.0060 -0.0225 0.1155)
+(-0.0060 -0.0195 0.1155)
+(-0.0030 -0.0195 0.1155)
+(0.0000 -0.0195 0.1155)
+(0.0030 -0.0195 0.1155)
+(0.0060 -0.0195 0.1155)
+(-0.0060 -0.0165 0.1155)
+(-0.0030 -0.0165 0.1155)
+(0.0000 -0.0165 0.1155)
+(0.0030 -0.0165 0.1155)
+(0.0060 -0.0165 0.1155)
+(-0.0060 -0.0135 0.1155)
+(-0.0030 -0.0135 0.1155)
+(0.0000 -0.0135 0.1155)
+(0.0030 -0.0135 0.1155)
+(0.0060 -0.0135 0.1155)
+(-0.0060 -0.0105 0.1155)
+(-0.0030 -0.0105 0.1155)
+(0.0000 -0.0105 0.1155)
+(0.0030 -0.0105 0.1155)
+(0.0060 -0.0105 0.1155)
+(-0.0060 -0.0075 0.1155)
+(-0.0030 -0.0075 0.1155)
+(0.0000 -0.0075 0.1155)
+(0.0030 -0.0075 0.1155)
+(0.0060 -0.0075 0.1155)
+(-0.0060 -0.0045 0.1155)
+(-0.0030 -0.0045 0.1155)
+(0.0000 -0.0045 0.1155)
+(0.0030 -0.0045 0.1155)
+(0.0060 -0.0045 0.1155)
+(-0.0060 -0.0015 0.1155)
+(-0.0030 -0.0015 0.1155)
+(0.0000 -0.0015 0.1155)
+(0.0030 -0.0015 0.1155)
+(0.0060 -0.0015 0.1155)
+(-0.0060 0.0015 0.1155)
+(-0.0030 0.0015 0.1155)
+(0.0000 0.0015 0.1155)
+(0.0030 0.0015 0.1155)
+(0.0060 0.0015 0.1155)
+(-0.0060 0.0045 0.1155)
+(-0.0030 0.0045 0.1155)
+(0.0000 0.0045 0.1155)
+(0.0030 0.0045 0.1155)
+(0.0060 0.0045 0.1155)
+(-0.0060 0.0075 0.1155)
+(-0.0030 0.0075 0.1155)
+(0.0000 0.0075 0.1155)
+(0.0030 0.0075 0.1155)
+(0.0060 0.0075 0.1155)
+(-0.0060 0.0105 0.1155)
+(-0.0030 0.0105 0.1155)
+(0.0000 0.0105 0.1155)
+(0.0030 0.0105 0.1155)
+(0.0060 0.0105 0.1155)
+(-0.0060 0.0135 0.1155)
+(-0.0030 0.0135 0.1155)
+(0.0000 0.0135 0.1155)
+(0.0030 0.0135 0.1155)
+(0.0060 0.0135 0.1155)
+(-0.0060 0.0165 0.1155)
+(-0.0030 0.0165 0.1155)
+(0.0000 0.0165 0.1155)
+(0.0030 0.0165 0.1155)
+(0.0060 0.0165 0.1155)
+(-0.0060 0.0195 0.1155)
+(-0.0030 0.0195 0.1155)
+(0.0000 0.0195 0.1155)
+(0.0030 0.0195 0.1155)
+(0.0060 0.0195 0.1155)
+(-0.0060 0.0225 0.1155)
+(-0.0030 0.0225 0.1155)
+(0.0000 0.0225 0.1155)
+(0.0030 0.0225 0.1155)
+(0.0060 0.0225 0.1155)
+(-0.0060 0.0255 0.1155)
+(-0.0030 0.0255 0.1155)
+(0.0000 0.0255 0.1155)
+(0.0030 0.0255 0.1155)
+(0.0060 0.0255 0.1155)
+(-0.0060 0.0285 0.1155)
+(-0.0030 0.0285 0.1155)
+(0.0000 0.0285 0.1155)
+(0.0030 0.0285 0.1155)
+(0.0060 0.0285 0.1155)
+(-0.0060 0.0315 0.1155)
+(-0.0030 0.0315 0.1155)
+(0.0000 0.0315 0.1155)
+(0.0030 0.0315 0.1155)
+(0.0060 0.0315 0.1155)
+(-0.0060 0.0345 0.1155)
+(-0.0030 0.0345 0.1155)
+(0.0000 0.0345 0.1155)
+(0.0030 0.0345 0.1155)
+(0.0060 0.0345 0.1155)
+(-0.0060 0.0375 0.1155)
+(-0.0030 0.0375 0.1155)
+(0.0000 0.0375 0.1155)
+(0.0030 0.0375 0.1155)
+(0.0060 0.0375 0.1155)
+(-0.0060 0.0405 0.1155)
+(-0.0030 0.0405 0.1155)
+(0.0000 0.0405 0.1155)
+(0.0030 0.0405 0.1155)
+(0.0060 0.0405 0.1155)
+(-0.0060 0.0435 0.1155)
+(-0.0030 0.0435 0.1155)
+(0.0000 0.0435 0.1155)
+(0.0030 0.0435 0.1155)
+(0.0060 0.0435 0.1155)
+(-0.0060 0.0465 0.1155)
+(-0.0030 0.0465 0.1155)
+(0.0000 0.0465 0.1155)
+(0.0030 0.0465 0.1155)
+(0.0060 0.0465 0.1155)
+(-0.0060 0.0495 0.1155)
+(-0.0030 0.0495 0.1155)
+(0.0000 0.0495 0.1155)
+(0.0030 0.0495 0.1155)
+(0.0060 0.0495 0.1155)
+(-0.0060 0.0525 0.1155)
+(-0.0030 0.0525 0.1155)
+(0.0000 0.0525 0.1155)
+(0.0030 0.0525 0.1155)
+(0.0060 0.0525 0.1155)
+(-0.0060 0.0555 0.1155)
+(-0.0030 0.0555 0.1155)
+(0.0000 0.0555 0.1155)
+(0.0030 0.0555 0.1155)
+(0.0060 0.0555 0.1155)
+(-0.0060 0.0585 0.1155)
+(-0.0030 0.0585 0.1155)
+(0.0000 0.0585 0.1155)
+(0.0030 0.0585 0.1155)
+(0.0060 0.0585 0.1155)
+(-0.0060 0.0615 0.1155)
+(-0.0030 0.0615 0.1155)
+(0.0000 0.0615 0.1155)
+(0.0030 0.0615 0.1155)
+(0.0060 0.0615 0.1155)
+(-0.0060 0.0645 0.1155)
+(-0.0030 0.0645 0.1155)
+(0.0000 0.0645 0.1155)
+(0.0030 0.0645 0.1155)
+(0.0060 0.0645 0.1155)
+(-0.0060 0.0675 0.1155)
+(-0.0030 0.0675 0.1155)
+(0.0000 0.0675 0.1155)
+(0.0030 0.0675 0.1155)
+(0.0060 0.0675 0.1155)
+(-0.0060 0.0705 0.1155)
+(-0.0030 0.0705 0.1155)
+(0.0000 0.0705 0.1155)
+(0.0030 0.0705 0.1155)
+(0.0060 0.0705 0.1155)
+(-0.0060 0.0735 0.1155)
+(-0.0030 0.0735 0.1155)
+(0.0000 0.0735 0.1155)
+(0.0030 0.0735 0.1155)
+(0.0060 0.0735 0.1155)
+(-0.0060 -0.0735 0.1185)
+(-0.0030 -0.0735 0.1185)
+(0.0000 -0.0735 0.1185)
+(0.0030 -0.0735 0.1185)
+(0.0060 -0.0735 0.1185)
+(-0.0060 -0.0705 0.1185)
+(-0.0030 -0.0705 0.1185)
+(0.0000 -0.0705 0.1185)
+(0.0030 -0.0705 0.1185)
+(0.0060 -0.0705 0.1185)
+(-0.0060 -0.0675 0.1185)
+(-0.0030 -0.0675 0.1185)
+(0.0000 -0.0675 0.1185)
+(0.0030 -0.0675 0.1185)
+(0.0060 -0.0675 0.1185)
+(-0.0060 -0.0645 0.1185)
+(-0.0030 -0.0645 0.1185)
+(0.0000 -0.0645 0.1185)
+(0.0030 -0.0645 0.1185)
+(0.0060 -0.0645 0.1185)
+(-0.0060 -0.0615 0.1185)
+(-0.0030 -0.0615 0.1185)
+(0.0000 -0.0615 0.1185)
+(0.0030 -0.0615 0.1185)
+(0.0060 -0.0615 0.1185)
+(-0.0060 -0.0585 0.1185)
+(-0.0030 -0.0585 0.1185)
+(0.0000 -0.0585 0.1185)
+(0.0030 -0.0585 0.1185)
+(0.0060 -0.0585 0.1185)
+(-0.0060 -0.0555 0.1185)
+(-0.0030 -0.0555 0.1185)
+(0.0000 -0.0555 0.1185)
+(0.0030 -0.0555 0.1185)
+(0.0060 -0.0555 0.1185)
+(-0.0060 -0.0525 0.1185)
+(-0.0030 -0.0525 0.1185)
+(0.0000 -0.0525 0.1185)
+(0.0030 -0.0525 0.1185)
+(0.0060 -0.0525 0.1185)
+(-0.0060 -0.0495 0.1185)
+(-0.0030 -0.0495 0.1185)
+(0.0000 -0.0495 0.1185)
+(0.0030 -0.0495 0.1185)
+(0.0060 -0.0495 0.1185)
+(-0.0060 -0.0465 0.1185)
+(-0.0030 -0.0465 0.1185)
+(0.0000 -0.0465 0.1185)
+(0.0030 -0.0465 0.1185)
+(0.0060 -0.0465 0.1185)
+(-0.0060 -0.0435 0.1185)
+(-0.0030 -0.0435 0.1185)
+(0.0000 -0.0435 0.1185)
+(0.0030 -0.0435 0.1185)
+(0.0060 -0.0435 0.1185)
+(-0.0060 -0.0405 0.1185)
+(-0.0030 -0.0405 0.1185)
+(0.0000 -0.0405 0.1185)
+(0.0030 -0.0405 0.1185)
+(0.0060 -0.0405 0.1185)
+(-0.0060 -0.0375 0.1185)
+(-0.0030 -0.0375 0.1185)
+(0.0000 -0.0375 0.1185)
+(0.0030 -0.0375 0.1185)
+(0.0060 -0.0375 0.1185)
+(-0.0060 -0.0345 0.1185)
+(-0.0030 -0.0345 0.1185)
+(0.0000 -0.0345 0.1185)
+(0.0030 -0.0345 0.1185)
+(0.0060 -0.0345 0.1185)
+(-0.0060 -0.0315 0.1185)
+(-0.0030 -0.0315 0.1185)
+(0.0000 -0.0315 0.1185)
+(0.0030 -0.0315 0.1185)
+(0.0060 -0.0315 0.1185)
+(-0.0060 -0.0285 0.1185)
+(-0.0030 -0.0285 0.1185)
+(0.0000 -0.0285 0.1185)
+(0.0030 -0.0285 0.1185)
+(0.0060 -0.0285 0.1185)
+(-0.0060 -0.0255 0.1185)
+(-0.0030 -0.0255 0.1185)
+(0.0000 -0.0255 0.1185)
+(0.0030 -0.0255 0.1185)
+(0.0060 -0.0255 0.1185)
+(-0.0060 -0.0225 0.1185)
+(-0.0030 -0.0225 0.1185)
+(0.0000 -0.0225 0.1185)
+(0.0030 -0.0225 0.1185)
+(0.0060 -0.0225 0.1185)
+(-0.0060 -0.0195 0.1185)
+(-0.0030 -0.0195 0.1185)
+(0.0000 -0.0195 0.1185)
+(0.0030 -0.0195 0.1185)
+(0.0060 -0.0195 0.1185)
+(-0.0060 -0.0165 0.1185)
+(-0.0030 -0.0165 0.1185)
+(0.0000 -0.0165 0.1185)
+(0.0030 -0.0165 0.1185)
+(0.0060 -0.0165 0.1185)
+(-0.0060 -0.0135 0.1185)
+(-0.0030 -0.0135 0.1185)
+(0.0000 -0.0135 0.1185)
+(0.0030 -0.0135 0.1185)
+(0.0060 -0.0135 0.1185)
+(-0.0060 -0.0105 0.1185)
+(-0.0030 -0.0105 0.1185)
+(0.0000 -0.0105 0.1185)
+(0.0030 -0.0105 0.1185)
+(0.0060 -0.0105 0.1185)
+(-0.0060 -0.0075 0.1185)
+(-0.0030 -0.0075 0.1185)
+(0.0000 -0.0075 0.1185)
+(0.0030 -0.0075 0.1185)
+(0.0060 -0.0075 0.1185)
+(-0.0060 -0.0045 0.1185)
+(-0.0030 -0.0045 0.1185)
+(0.0000 -0.0045 0.1185)
+(0.0030 -0.0045 0.1185)
+(0.0060 -0.0045 0.1185)
+(-0.0060 -0.0015 0.1185)
+(-0.0030 -0.0015 0.1185)
+(0.0000 -0.0015 0.1185)
+(0.0030 -0.0015 0.1185)
+(0.0060 -0.0015 0.1185)
+(-0.0060 0.0015 0.1185)
+(-0.0030 0.0015 0.1185)
+(0.0000 0.0015 0.1185)
+(0.0030 0.0015 0.1185)
+(0.0060 0.0015 0.1185)
+(-0.0060 0.0045 0.1185)
+(-0.0030 0.0045 0.1185)
+(0.0000 0.0045 0.1185)
+(0.0030 0.0045 0.1185)
+(0.0060 0.0045 0.1185)
+(-0.0060 0.0075 0.1185)
+(-0.0030 0.0075 0.1185)
+(0.0000 0.0075 0.1185)
+(0.0030 0.0075 0.1185)
+(0.0060 0.0075 0.1185)
+(-0.0060 0.0105 0.1185)
+(-0.0030 0.0105 0.1185)
+(0.0000 0.0105 0.1185)
+(0.0030 0.0105 0.1185)
+(0.0060 0.0105 0.1185)
+(-0.0060 0.0135 0.1185)
+(-0.0030 0.0135 0.1185)
+(0.0000 0.0135 0.1185)
+(0.0030 0.0135 0.1185)
+(0.0060 0.0135 0.1185)
+(-0.0060 0.0165 0.1185)
+(-0.0030 0.0165 0.1185)
+(0.0000 0.0165 0.1185)
+(0.0030 0.0165 0.1185)
+(0.0060 0.0165 0.1185)
+(-0.0060 0.0195 0.1185)
+(-0.0030 0.0195 0.1185)
+(0.0000 0.0195 0.1185)
+(0.0030 0.0195 0.1185)
+(0.0060 0.0195 0.1185)
+(-0.0060 0.0225 0.1185)
+(-0.0030 0.0225 0.1185)
+(0.0000 0.0225 0.1185)
+(0.0030 0.0225 0.1185)
+(0.0060 0.0225 0.1185)
+(-0.0060 0.0255 0.1185)
+(-0.0030 0.0255 0.1185)
+(0.0000 0.0255 0.1185)
+(0.0030 0.0255 0.1185)
+(0.0060 0.0255 0.1185)
+(-0.0060 0.0285 0.1185)
+(-0.0030 0.0285 0.1185)
+(0.0000 0.0285 0.1185)
+(0.0030 0.0285 0.1185)
+(0.0060 0.0285 0.1185)
+(-0.0060 0.0315 0.1185)
+(-0.0030 0.0315 0.1185)
+(0.0000 0.0315 0.1185)
+(0.0030 0.0315 0.1185)
+(0.0060 0.0315 0.1185)
+(-0.0060 0.0345 0.1185)
+(-0.0030 0.0345 0.1185)
+(0.0000 0.0345 0.1185)
+(0.0030 0.0345 0.1185)
+(0.0060 0.0345 0.1185)
+(-0.0060 0.0375 0.1185)
+(-0.0030 0.0375 0.1185)
+(0.0000 0.0375 0.1185)
+(0.0030 0.0375 0.1185)
+(0.0060 0.0375 0.1185)
+(-0.0060 0.0405 0.1185)
+(-0.0030 0.0405 0.1185)
+(0.0000 0.0405 0.1185)
+(0.0030 0.0405 0.1185)
+(0.0060 0.0405 0.1185)
+(-0.0060 0.0435 0.1185)
+(-0.0030 0.0435 0.1185)
+(0.0000 0.0435 0.1185)
+(0.0030 0.0435 0.1185)
+(0.0060 0.0435 0.1185)
+(-0.0060 0.0465 0.1185)
+(-0.0030 0.0465 0.1185)
+(0.0000 0.0465 0.1185)
+(0.0030 0.0465 0.1185)
+(0.0060 0.0465 0.1185)
+(-0.0060 0.0495 0.1185)
+(-0.0030 0.0495 0.1185)
+(0.0000 0.0495 0.1185)
+(0.0030 0.0495 0.1185)
+(0.0060 0.0495 0.1185)
+(-0.0060 0.0525 0.1185)
+(-0.0030 0.0525 0.1185)
+(0.0000 0.0525 0.1185)
+(0.0030 0.0525 0.1185)
+(0.0060 0.0525 0.1185)
+(-0.0060 0.0555 0.1185)
+(-0.0030 0.0555 0.1185)
+(0.0000 0.0555 0.1185)
+(0.0030 0.0555 0.1185)
+(0.0060 0.0555 0.1185)
+(-0.0060 0.0585 0.1185)
+(-0.0030 0.0585 0.1185)
+(0.0000 0.0585 0.1185)
+(0.0030 0.0585 0.1185)
+(0.0060 0.0585 0.1185)
+(-0.0060 0.0615 0.1185)
+(-0.0030 0.0615 0.1185)
+(0.0000 0.0615 0.1185)
+(0.0030 0.0615 0.1185)
+(0.0060 0.0615 0.1185)
+(-0.0060 0.0645 0.1185)
+(-0.0030 0.0645 0.1185)
+(0.0000 0.0645 0.1185)
+(0.0030 0.0645 0.1185)
+(0.0060 0.0645 0.1185)
+(-0.0060 0.0675 0.1185)
+(-0.0030 0.0675 0.1185)
+(0.0000 0.0675 0.1185)
+(0.0030 0.0675 0.1185)
+(0.0060 0.0675 0.1185)
+(-0.0060 0.0705 0.1185)
+(-0.0030 0.0705 0.1185)
+(0.0000 0.0705 0.1185)
+(0.0030 0.0705 0.1185)
+(0.0060 0.0705 0.1185)
+(-0.0060 0.0735 0.1185)
+(-0.0030 0.0735 0.1185)
+(0.0000 0.0735 0.1185)
+(0.0030 0.0735 0.1185)
+(0.0060 0.0735 0.1185)
+(-0.0060 -0.0735 0.1215)
+(-0.0030 -0.0735 0.1215)
+(0.0000 -0.0735 0.1215)
+(0.0030 -0.0735 0.1215)
+(0.0060 -0.0735 0.1215)
+(-0.0060 -0.0705 0.1215)
+(-0.0030 -0.0705 0.1215)
+(0.0000 -0.0705 0.1215)
+(0.0030 -0.0705 0.1215)
+(0.0060 -0.0705 0.1215)
+(-0.0060 -0.0675 0.1215)
+(-0.0030 -0.0675 0.1215)
+(0.0000 -0.0675 0.1215)
+(0.0030 -0.0675 0.1215)
+(0.0060 -0.0675 0.1215)
+(-0.0060 -0.0645 0.1215)
+(-0.0030 -0.0645 0.1215)
+(0.0000 -0.0645 0.1215)
+(0.0030 -0.0645 0.1215)
+(0.0060 -0.0645 0.1215)
+(-0.0060 -0.0615 0.1215)
+(-0.0030 -0.0615 0.1215)
+(0.0000 -0.0615 0.1215)
+(0.0030 -0.0615 0.1215)
+(0.0060 -0.0615 0.1215)
+(-0.0060 -0.0585 0.1215)
+(-0.0030 -0.0585 0.1215)
+(0.0000 -0.0585 0.1215)
+(0.0030 -0.0585 0.1215)
+(0.0060 -0.0585 0.1215)
+(-0.0060 -0.0555 0.1215)
+(-0.0030 -0.0555 0.1215)
+(0.0000 -0.0555 0.1215)
+(0.0030 -0.0555 0.1215)
+(0.0060 -0.0555 0.1215)
+(-0.0060 -0.0525 0.1215)
+(-0.0030 -0.0525 0.1215)
+(0.0000 -0.0525 0.1215)
+(0.0030 -0.0525 0.1215)
+(0.0060 -0.0525 0.1215)
+(-0.0060 -0.0495 0.1215)
+(-0.0030 -0.0495 0.1215)
+(0.0000 -0.0495 0.1215)
+(0.0030 -0.0495 0.1215)
+(0.0060 -0.0495 0.1215)
+(-0.0060 -0.0465 0.1215)
+(-0.0030 -0.0465 0.1215)
+(0.0000 -0.0465 0.1215)
+(0.0030 -0.0465 0.1215)
+(0.0060 -0.0465 0.1215)
+(-0.0060 -0.0435 0.1215)
+(-0.0030 -0.0435 0.1215)
+(0.0000 -0.0435 0.1215)
+(0.0030 -0.0435 0.1215)
+(0.0060 -0.0435 0.1215)
+(-0.0060 -0.0405 0.1215)
+(-0.0030 -0.0405 0.1215)
+(0.0000 -0.0405 0.1215)
+(0.0030 -0.0405 0.1215)
+(0.0060 -0.0405 0.1215)
+(-0.0060 -0.0375 0.1215)
+(-0.0030 -0.0375 0.1215)
+(0.0000 -0.0375 0.1215)
+(0.0030 -0.0375 0.1215)
+(0.0060 -0.0375 0.1215)
+(-0.0060 -0.0345 0.1215)
+(-0.0030 -0.0345 0.1215)
+(0.0000 -0.0345 0.1215)
+(0.0030 -0.0345 0.1215)
+(0.0060 -0.0345 0.1215)
+(-0.0060 -0.0315 0.1215)
+(-0.0030 -0.0315 0.1215)
+(0.0000 -0.0315 0.1215)
+(0.0030 -0.0315 0.1215)
+(0.0060 -0.0315 0.1215)
+(-0.0060 -0.0285 0.1215)
+(-0.0030 -0.0285 0.1215)
+(0.0000 -0.0285 0.1215)
+(0.0030 -0.0285 0.1215)
+(0.0060 -0.0285 0.1215)
+(-0.0060 -0.0255 0.1215)
+(-0.0030 -0.0255 0.1215)
+(0.0000 -0.0255 0.1215)
+(0.0030 -0.0255 0.1215)
+(0.0060 -0.0255 0.1215)
+(-0.0060 -0.0225 0.1215)
+(-0.0030 -0.0225 0.1215)
+(0.0000 -0.0225 0.1215)
+(0.0030 -0.0225 0.1215)
+(0.0060 -0.0225 0.1215)
+(-0.0060 -0.0195 0.1215)
+(-0.0030 -0.0195 0.1215)
+(0.0000 -0.0195 0.1215)
+(0.0030 -0.0195 0.1215)
+(0.0060 -0.0195 0.1215)
+(-0.0060 -0.0165 0.1215)
+(-0.0030 -0.0165 0.1215)
+(0.0000 -0.0165 0.1215)
+(0.0030 -0.0165 0.1215)
+(0.0060 -0.0165 0.1215)
+(-0.0060 -0.0135 0.1215)
+(-0.0030 -0.0135 0.1215)
+(0.0000 -0.0135 0.1215)
+(0.0030 -0.0135 0.1215)
+(0.0060 -0.0135 0.1215)
+(-0.0060 -0.0105 0.1215)
+(-0.0030 -0.0105 0.1215)
+(0.0000 -0.0105 0.1215)
+(0.0030 -0.0105 0.1215)
+(0.0060 -0.0105 0.1215)
+(-0.0060 -0.0075 0.1215)
+(-0.0030 -0.0075 0.1215)
+(0.0000 -0.0075 0.1215)
+(0.0030 -0.0075 0.1215)
+(0.0060 -0.0075 0.1215)
+(-0.0060 -0.0045 0.1215)
+(-0.0030 -0.0045 0.1215)
+(0.0000 -0.0045 0.1215)
+(0.0030 -0.0045 0.1215)
+(0.0060 -0.0045 0.1215)
+(-0.0060 -0.0015 0.1215)
+(-0.0030 -0.0015 0.1215)
+(0.0000 -0.0015 0.1215)
+(0.0030 -0.0015 0.1215)
+(0.0060 -0.0015 0.1215)
+(-0.0060 0.0015 0.1215)
+(-0.0030 0.0015 0.1215)
+(0.0000 0.0015 0.1215)
+(0.0030 0.0015 0.1215)
+(0.0060 0.0015 0.1215)
+(-0.0060 0.0045 0.1215)
+(-0.0030 0.0045 0.1215)
+(0.0000 0.0045 0.1215)
+(0.0030 0.0045 0.1215)
+(0.0060 0.0045 0.1215)
+(-0.0060 0.0075 0.1215)
+(-0.0030 0.0075 0.1215)
+(0.0000 0.0075 0.1215)
+(0.0030 0.0075 0.1215)
+(0.0060 0.0075 0.1215)
+(-0.0060 0.0105 0.1215)
+(-0.0030 0.0105 0.1215)
+(0.0000 0.0105 0.1215)
+(0.0030 0.0105 0.1215)
+(0.0060 0.0105 0.1215)
+(-0.0060 0.0135 0.1215)
+(-0.0030 0.0135 0.1215)
+(0.0000 0.0135 0.1215)
+(0.0030 0.0135 0.1215)
+(0.0060 0.0135 0.1215)
+(-0.0060 0.0165 0.1215)
+(-0.0030 0.0165 0.1215)
+(0.0000 0.0165 0.1215)
+(0.0030 0.0165 0.1215)
+(0.0060 0.0165 0.1215)
+(-0.0060 0.0195 0.1215)
+(-0.0030 0.0195 0.1215)
+(0.0000 0.0195 0.1215)
+(0.0030 0.0195 0.1215)
+(0.0060 0.0195 0.1215)
+(-0.0060 0.0225 0.1215)
+(-0.0030 0.0225 0.1215)
+(0.0000 0.0225 0.1215)
+(0.0030 0.0225 0.1215)
+(0.0060 0.0225 0.1215)
+(-0.0060 0.0255 0.1215)
+(-0.0030 0.0255 0.1215)
+(0.0000 0.0255 0.1215)
+(0.0030 0.0255 0.1215)
+(0.0060 0.0255 0.1215)
+(-0.0060 0.0285 0.1215)
+(-0.0030 0.0285 0.1215)
+(0.0000 0.0285 0.1215)
+(0.0030 0.0285 0.1215)
+(0.0060 0.0285 0.1215)
+(-0.0060 0.0315 0.1215)
+(-0.0030 0.0315 0.1215)
+(0.0000 0.0315 0.1215)
+(0.0030 0.0315 0.1215)
+(0.0060 0.0315 0.1215)
+(-0.0060 0.0345 0.1215)
+(-0.0030 0.0345 0.1215)
+(0.0000 0.0345 0.1215)
+(0.0030 0.0345 0.1215)
+(0.0060 0.0345 0.1215)
+(-0.0060 0.0375 0.1215)
+(-0.0030 0.0375 0.1215)
+(0.0000 0.0375 0.1215)
+(0.0030 0.0375 0.1215)
+(0.0060 0.0375 0.1215)
+(-0.0060 0.0405 0.1215)
+(-0.0030 0.0405 0.1215)
+(0.0000 0.0405 0.1215)
+(0.0030 0.0405 0.1215)
+(0.0060 0.0405 0.1215)
+(-0.0060 0.0435 0.1215)
+(-0.0030 0.0435 0.1215)
+(0.0000 0.0435 0.1215)
+(0.0030 0.0435 0.1215)
+(0.0060 0.0435 0.1215)
+(-0.0060 0.0465 0.1215)
+(-0.0030 0.0465 0.1215)
+(0.0000 0.0465 0.1215)
+(0.0030 0.0465 0.1215)
+(0.0060 0.0465 0.1215)
+(-0.0060 0.0495 0.1215)
+(-0.0030 0.0495 0.1215)
+(0.0000 0.0495 0.1215)
+(0.0030 0.0495 0.1215)
+(0.0060 0.0495 0.1215)
+(-0.0060 0.0525 0.1215)
+(-0.0030 0.0525 0.1215)
+(0.0000 0.0525 0.1215)
+(0.0030 0.0525 0.1215)
+(0.0060 0.0525 0.1215)
+(-0.0060 0.0555 0.1215)
+(-0.0030 0.0555 0.1215)
+(0.0000 0.0555 0.1215)
+(0.0030 0.0555 0.1215)
+(0.0060 0.0555 0.1215)
+(-0.0060 0.0585 0.1215)
+(-0.0030 0.0585 0.1215)
+(0.0000 0.0585 0.1215)
+(0.0030 0.0585 0.1215)
+(0.0060 0.0585 0.1215)
+(-0.0060 0.0615 0.1215)
+(-0.0030 0.0615 0.1215)
+(0.0000 0.0615 0.1215)
+(0.0030 0.0615 0.1215)
+(0.0060 0.0615 0.1215)
+(-0.0060 0.0645 0.1215)
+(-0.0030 0.0645 0.1215)
+(0.0000 0.0645 0.1215)
+(0.0030 0.0645 0.1215)
+(0.0060 0.0645 0.1215)
+(-0.0060 0.0675 0.1215)
+(-0.0030 0.0675 0.1215)
+(0.0000 0.0675 0.1215)
+(0.0030 0.0675 0.1215)
+(0.0060 0.0675 0.1215)
+(-0.0060 0.0705 0.1215)
+(-0.0030 0.0705 0.1215)
+(0.0000 0.0705 0.1215)
+(0.0030 0.0705 0.1215)
+(0.0060 0.0705 0.1215)
+(-0.0060 0.0735 0.1215)
+(-0.0030 0.0735 0.1215)
+(0.0000 0.0735 0.1215)
+(0.0030 0.0735 0.1215)
+(0.0060 0.0735 0.1215)
+(-0.0060 -0.0735 0.1245)
+(-0.0030 -0.0735 0.1245)
+(0.0000 -0.0735 0.1245)
+(0.0030 -0.0735 0.1245)
+(0.0060 -0.0735 0.1245)
+(-0.0060 -0.0705 0.1245)
+(-0.0030 -0.0705 0.1245)
+(0.0000 -0.0705 0.1245)
+(0.0030 -0.0705 0.1245)
+(0.0060 -0.0705 0.1245)
+(-0.0060 -0.0675 0.1245)
+(-0.0030 -0.0675 0.1245)
+(0.0000 -0.0675 0.1245)
+(0.0030 -0.0675 0.1245)
+(0.0060 -0.0675 0.1245)
+(-0.0060 -0.0645 0.1245)
+(-0.0030 -0.0645 0.1245)
+(0.0000 -0.0645 0.1245)
+(0.0030 -0.0645 0.1245)
+(0.0060 -0.0645 0.1245)
+(-0.0060 -0.0615 0.1245)
+(-0.0030 -0.0615 0.1245)
+(0.0000 -0.0615 0.1245)
+(0.0030 -0.0615 0.1245)
+(0.0060 -0.0615 0.1245)
+(-0.0060 -0.0585 0.1245)
+(-0.0030 -0.0585 0.1245)
+(0.0000 -0.0585 0.1245)
+(0.0030 -0.0585 0.1245)
+(0.0060 -0.0585 0.1245)
+(-0.0060 -0.0555 0.1245)
+(-0.0030 -0.0555 0.1245)
+(0.0000 -0.0555 0.1245)
+(0.0030 -0.0555 0.1245)
+(0.0060 -0.0555 0.1245)
+(-0.0060 -0.0525 0.1245)
+(-0.0030 -0.0525 0.1245)
+(0.0000 -0.0525 0.1245)
+(0.0030 -0.0525 0.1245)
+(0.0060 -0.0525 0.1245)
+(-0.0060 -0.0495 0.1245)
+(-0.0030 -0.0495 0.1245)
+(0.0000 -0.0495 0.1245)
+(0.0030 -0.0495 0.1245)
+(0.0060 -0.0495 0.1245)
+(-0.0060 -0.0465 0.1245)
+(-0.0030 -0.0465 0.1245)
+(0.0000 -0.0465 0.1245)
+(0.0030 -0.0465 0.1245)
+(0.0060 -0.0465 0.1245)
+(-0.0060 -0.0435 0.1245)
+(-0.0030 -0.0435 0.1245)
+(0.0000 -0.0435 0.1245)
+(0.0030 -0.0435 0.1245)
+(0.0060 -0.0435 0.1245)
+(-0.0060 -0.0405 0.1245)
+(-0.0030 -0.0405 0.1245)
+(0.0000 -0.0405 0.1245)
+(0.0030 -0.0405 0.1245)
+(0.0060 -0.0405 0.1245)
+(-0.0060 -0.0375 0.1245)
+(-0.0030 -0.0375 0.1245)
+(0.0000 -0.0375 0.1245)
+(0.0030 -0.0375 0.1245)
+(0.0060 -0.0375 0.1245)
+(-0.0060 -0.0345 0.1245)
+(-0.0030 -0.0345 0.1245)
+(0.0000 -0.0345 0.1245)
+(0.0030 -0.0345 0.1245)
+(0.0060 -0.0345 0.1245)
+(-0.0060 -0.0315 0.1245)
+(-0.0030 -0.0315 0.1245)
+(0.0000 -0.0315 0.1245)
+(0.0030 -0.0315 0.1245)
+(0.0060 -0.0315 0.1245)
+(-0.0060 -0.0285 0.1245)
+(-0.0030 -0.0285 0.1245)
+(0.0000 -0.0285 0.1245)
+(0.0030 -0.0285 0.1245)
+(0.0060 -0.0285 0.1245)
+(-0.0060 -0.0255 0.1245)
+(-0.0030 -0.0255 0.1245)
+(0.0000 -0.0255 0.1245)
+(0.0030 -0.0255 0.1245)
+(0.0060 -0.0255 0.1245)
+(-0.0060 -0.0225 0.1245)
+(-0.0030 -0.0225 0.1245)
+(0.0000 -0.0225 0.1245)
+(0.0030 -0.0225 0.1245)
+(0.0060 -0.0225 0.1245)
+(-0.0060 -0.0195 0.1245)
+(-0.0030 -0.0195 0.1245)
+(0.0000 -0.0195 0.1245)
+(0.0030 -0.0195 0.1245)
+(0.0060 -0.0195 0.1245)
+(-0.0060 -0.0165 0.1245)
+(-0.0030 -0.0165 0.1245)
+(0.0000 -0.0165 0.1245)
+(0.0030 -0.0165 0.1245)
+(0.0060 -0.0165 0.1245)
+(-0.0060 -0.0135 0.1245)
+(-0.0030 -0.0135 0.1245)
+(0.0000 -0.0135 0.1245)
+(0.0030 -0.0135 0.1245)
+(0.0060 -0.0135 0.1245)
+(-0.0060 -0.0105 0.1245)
+(-0.0030 -0.0105 0.1245)
+(0.0000 -0.0105 0.1245)
+(0.0030 -0.0105 0.1245)
+(0.0060 -0.0105 0.1245)
+(-0.0060 -0.0075 0.1245)
+(-0.0030 -0.0075 0.1245)
+(0.0000 -0.0075 0.1245)
+(0.0030 -0.0075 0.1245)
+(0.0060 -0.0075 0.1245)
+(-0.0060 -0.0045 0.1245)
+(-0.0030 -0.0045 0.1245)
+(0.0000 -0.0045 0.1245)
+(0.0030 -0.0045 0.1245)
+(0.0060 -0.0045 0.1245)
+(-0.0060 -0.0015 0.1245)
+(-0.0030 -0.0015 0.1245)
+(0.0000 -0.0015 0.1245)
+(0.0030 -0.0015 0.1245)
+(0.0060 -0.0015 0.1245)
+(-0.0060 0.0015 0.1245)
+(-0.0030 0.0015 0.1245)
+(0.0000 0.0015 0.1245)
+(0.0030 0.0015 0.1245)
+(0.0060 0.0015 0.1245)
+(-0.0060 0.0045 0.1245)
+(-0.0030 0.0045 0.1245)
+(0.0000 0.0045 0.1245)
+(0.0030 0.0045 0.1245)
+(0.0060 0.0045 0.1245)
+(-0.0060 0.0075 0.1245)
+(-0.0030 0.0075 0.1245)
+(0.0000 0.0075 0.1245)
+(0.0030 0.0075 0.1245)
+(0.0060 0.0075 0.1245)
+(-0.0060 0.0105 0.1245)
+(-0.0030 0.0105 0.1245)
+(0.0000 0.0105 0.1245)
+(0.0030 0.0105 0.1245)
+(0.0060 0.0105 0.1245)
+(-0.0060 0.0135 0.1245)
+(-0.0030 0.0135 0.1245)
+(0.0000 0.0135 0.1245)
+(0.0030 0.0135 0.1245)
+(0.0060 0.0135 0.1245)
+(-0.0060 0.0165 0.1245)
+(-0.0030 0.0165 0.1245)
+(0.0000 0.0165 0.1245)
+(0.0030 0.0165 0.1245)
+(0.0060 0.0165 0.1245)
+(-0.0060 0.0195 0.1245)
+(-0.0030 0.0195 0.1245)
+(0.0000 0.0195 0.1245)
+(0.0030 0.0195 0.1245)
+(0.0060 0.0195 0.1245)
+(-0.0060 0.0225 0.1245)
+(-0.0030 0.0225 0.1245)
+(0.0000 0.0225 0.1245)
+(0.0030 0.0225 0.1245)
+(0.0060 0.0225 0.1245)
+(-0.0060 0.0255 0.1245)
+(-0.0030 0.0255 0.1245)
+(0.0000 0.0255 0.1245)
+(0.0030 0.0255 0.1245)
+(0.0060 0.0255 0.1245)
+(-0.0060 0.0285 0.1245)
+(-0.0030 0.0285 0.1245)
+(0.0000 0.0285 0.1245)
+(0.0030 0.0285 0.1245)
+(0.0060 0.0285 0.1245)
+(-0.0060 0.0315 0.1245)
+(-0.0030 0.0315 0.1245)
+(0.0000 0.0315 0.1245)
+(0.0030 0.0315 0.1245)
+(0.0060 0.0315 0.1245)
+(-0.0060 0.0345 0.1245)
+(-0.0030 0.0345 0.1245)
+(0.0000 0.0345 0.1245)
+(0.0030 0.0345 0.1245)
+(0.0060 0.0345 0.1245)
+(-0.0060 0.0375 0.1245)
+(-0.0030 0.0375 0.1245)
+(0.0000 0.0375 0.1245)
+(0.0030 0.0375 0.1245)
+(0.0060 0.0375 0.1245)
+(-0.0060 0.0405 0.1245)
+(-0.0030 0.0405 0.1245)
+(0.0000 0.0405 0.1245)
+(0.0030 0.0405 0.1245)
+(0.0060 0.0405 0.1245)
+(-0.0060 0.0435 0.1245)
+(-0.0030 0.0435 0.1245)
+(0.0000 0.0435 0.1245)
+(0.0030 0.0435 0.1245)
+(0.0060 0.0435 0.1245)
+(-0.0060 0.0465 0.1245)
+(-0.0030 0.0465 0.1245)
+(0.0000 0.0465 0.1245)
+(0.0030 0.0465 0.1245)
+(0.0060 0.0465 0.1245)
+(-0.0060 0.0495 0.1245)
+(-0.0030 0.0495 0.1245)
+(0.0000 0.0495 0.1245)
+(0.0030 0.0495 0.1245)
+(0.0060 0.0495 0.1245)
+(-0.0060 0.0525 0.1245)
+(-0.0030 0.0525 0.1245)
+(0.0000 0.0525 0.1245)
+(0.0030 0.0525 0.1245)
+(0.0060 0.0525 0.1245)
+(-0.0060 0.0555 0.1245)
+(-0.0030 0.0555 0.1245)
+(0.0000 0.0555 0.1245)
+(0.0030 0.0555 0.1245)
+(0.0060 0.0555 0.1245)
+(-0.0060 0.0585 0.1245)
+(-0.0030 0.0585 0.1245)
+(0.0000 0.0585 0.1245)
+(0.0030 0.0585 0.1245)
+(0.0060 0.0585 0.1245)
+(-0.0060 0.0615 0.1245)
+(-0.0030 0.0615 0.1245)
+(0.0000 0.0615 0.1245)
+(0.0030 0.0615 0.1245)
+(0.0060 0.0615 0.1245)
+(-0.0060 0.0645 0.1245)
+(-0.0030 0.0645 0.1245)
+(0.0000 0.0645 0.1245)
+(0.0030 0.0645 0.1245)
+(0.0060 0.0645 0.1245)
+(-0.0060 0.0675 0.1245)
+(-0.0030 0.0675 0.1245)
+(0.0000 0.0675 0.1245)
+(0.0030 0.0675 0.1245)
+(0.0060 0.0675 0.1245)
+(-0.0060 0.0705 0.1245)
+(-0.0030 0.0705 0.1245)
+(0.0000 0.0705 0.1245)
+(0.0030 0.0705 0.1245)
+(0.0060 0.0705 0.1245)
+(-0.0060 0.0735 0.1245)
+(-0.0030 0.0735 0.1245)
+(0.0000 0.0735 0.1245)
+(0.0030 0.0735 0.1245)
+(0.0060 0.0735 0.1245)
+(-0.0060 -0.0735 0.1275)
+(-0.0030 -0.0735 0.1275)
+(0.0000 -0.0735 0.1275)
+(0.0030 -0.0735 0.1275)
+(0.0060 -0.0735 0.1275)
+(-0.0060 -0.0705 0.1275)
+(-0.0030 -0.0705 0.1275)
+(0.0000 -0.0705 0.1275)
+(0.0030 -0.0705 0.1275)
+(0.0060 -0.0705 0.1275)
+(-0.0060 -0.0675 0.1275)
+(-0.0030 -0.0675 0.1275)
+(0.0000 -0.0675 0.1275)
+(0.0030 -0.0675 0.1275)
+(0.0060 -0.0675 0.1275)
+(-0.0060 -0.0645 0.1275)
+(-0.0030 -0.0645 0.1275)
+(0.0000 -0.0645 0.1275)
+(0.0030 -0.0645 0.1275)
+(0.0060 -0.0645 0.1275)
+(-0.0060 -0.0615 0.1275)
+(-0.0030 -0.0615 0.1275)
+(0.0000 -0.0615 0.1275)
+(0.0030 -0.0615 0.1275)
+(0.0060 -0.0615 0.1275)
+(-0.0060 -0.0585 0.1275)
+(-0.0030 -0.0585 0.1275)
+(0.0000 -0.0585 0.1275)
+(0.0030 -0.0585 0.1275)
+(0.0060 -0.0585 0.1275)
+(-0.0060 -0.0555 0.1275)
+(-0.0030 -0.0555 0.1275)
+(0.0000 -0.0555 0.1275)
+(0.0030 -0.0555 0.1275)
+(0.0060 -0.0555 0.1275)
+(-0.0060 -0.0525 0.1275)
+(-0.0030 -0.0525 0.1275)
+(0.0000 -0.0525 0.1275)
+(0.0030 -0.0525 0.1275)
+(0.0060 -0.0525 0.1275)
+(-0.0060 -0.0495 0.1275)
+(-0.0030 -0.0495 0.1275)
+(0.0000 -0.0495 0.1275)
+(0.0030 -0.0495 0.1275)
+(0.0060 -0.0495 0.1275)
+(-0.0060 -0.0465 0.1275)
+(-0.0030 -0.0465 0.1275)
+(0.0000 -0.0465 0.1275)
+(0.0030 -0.0465 0.1275)
+(0.0060 -0.0465 0.1275)
+(-0.0060 -0.0435 0.1275)
+(-0.0030 -0.0435 0.1275)
+(0.0000 -0.0435 0.1275)
+(0.0030 -0.0435 0.1275)
+(0.0060 -0.0435 0.1275)
+(-0.0060 -0.0405 0.1275)
+(-0.0030 -0.0405 0.1275)
+(0.0000 -0.0405 0.1275)
+(0.0030 -0.0405 0.1275)
+(0.0060 -0.0405 0.1275)
+(-0.0060 -0.0375 0.1275)
+(-0.0030 -0.0375 0.1275)
+(0.0000 -0.0375 0.1275)
+(0.0030 -0.0375 0.1275)
+(0.0060 -0.0375 0.1275)
+(-0.0060 -0.0345 0.1275)
+(-0.0030 -0.0345 0.1275)
+(0.0000 -0.0345 0.1275)
+(0.0030 -0.0345 0.1275)
+(0.0060 -0.0345 0.1275)
+(-0.0060 -0.0315 0.1275)
+(-0.0030 -0.0315 0.1275)
+(0.0000 -0.0315 0.1275)
+(0.0030 -0.0315 0.1275)
+(0.0060 -0.0315 0.1275)
+(-0.0060 -0.0285 0.1275)
+(-0.0030 -0.0285 0.1275)
+(0.0000 -0.0285 0.1275)
+(0.0030 -0.0285 0.1275)
+(0.0060 -0.0285 0.1275)
+(-0.0060 -0.0255 0.1275)
+(-0.0030 -0.0255 0.1275)
+(0.0000 -0.0255 0.1275)
+(0.0030 -0.0255 0.1275)
+(0.0060 -0.0255 0.1275)
+(-0.0060 -0.0225 0.1275)
+(-0.0030 -0.0225 0.1275)
+(0.0000 -0.0225 0.1275)
+(0.0030 -0.0225 0.1275)
+(0.0060 -0.0225 0.1275)
+(-0.0060 -0.0195 0.1275)
+(-0.0030 -0.0195 0.1275)
+(0.0000 -0.0195 0.1275)
+(0.0030 -0.0195 0.1275)
+(0.0060 -0.0195 0.1275)
+(-0.0060 -0.0165 0.1275)
+(-0.0030 -0.0165 0.1275)
+(0.0000 -0.0165 0.1275)
+(0.0030 -0.0165 0.1275)
+(0.0060 -0.0165 0.1275)
+(-0.0060 -0.0135 0.1275)
+(-0.0030 -0.0135 0.1275)
+(0.0000 -0.0135 0.1275)
+(0.0030 -0.0135 0.1275)
+(0.0060 -0.0135 0.1275)
+(-0.0060 -0.0105 0.1275)
+(-0.0030 -0.0105 0.1275)
+(0.0000 -0.0105 0.1275)
+(0.0030 -0.0105 0.1275)
+(0.0060 -0.0105 0.1275)
+(-0.0060 -0.0075 0.1275)
+(-0.0030 -0.0075 0.1275)
+(0.0000 -0.0075 0.1275)
+(0.0030 -0.0075 0.1275)
+(0.0060 -0.0075 0.1275)
+(-0.0060 -0.0045 0.1275)
+(-0.0030 -0.0045 0.1275)
+(0.0000 -0.0045 0.1275)
+(0.0030 -0.0045 0.1275)
+(0.0060 -0.0045 0.1275)
+(-0.0060 -0.0015 0.1275)
+(-0.0030 -0.0015 0.1275)
+(0.0000 -0.0015 0.1275)
+(0.0030 -0.0015 0.1275)
+(0.0060 -0.0015 0.1275)
+(-0.0060 0.0015 0.1275)
+(-0.0030 0.0015 0.1275)
+(0.0000 0.0015 0.1275)
+(0.0030 0.0015 0.1275)
+(0.0060 0.0015 0.1275)
+(-0.0060 0.0045 0.1275)
+(-0.0030 0.0045 0.1275)
+(0.0000 0.0045 0.1275)
+(0.0030 0.0045 0.1275)
+(0.0060 0.0045 0.1275)
+(-0.0060 0.0075 0.1275)
+(-0.0030 0.0075 0.1275)
+(0.0000 0.0075 0.1275)
+(0.0030 0.0075 0.1275)
+(0.0060 0.0075 0.1275)
+(-0.0060 0.0105 0.1275)
+(-0.0030 0.0105 0.1275)
+(0.0000 0.0105 0.1275)
+(0.0030 0.0105 0.1275)
+(0.0060 0.0105 0.1275)
+(-0.0060 0.0135 0.1275)
+(-0.0030 0.0135 0.1275)
+(0.0000 0.0135 0.1275)
+(0.0030 0.0135 0.1275)
+(0.0060 0.0135 0.1275)
+(-0.0060 0.0165 0.1275)
+(-0.0030 0.0165 0.1275)
+(0.0000 0.0165 0.1275)
+(0.0030 0.0165 0.1275)
+(0.0060 0.0165 0.1275)
+(-0.0060 0.0195 0.1275)
+(-0.0030 0.0195 0.1275)
+(0.0000 0.0195 0.1275)
+(0.0030 0.0195 0.1275)
+(0.0060 0.0195 0.1275)
+(-0.0060 0.0225 0.1275)
+(-0.0030 0.0225 0.1275)
+(0.0000 0.0225 0.1275)
+(0.0030 0.0225 0.1275)
+(0.0060 0.0225 0.1275)
+(-0.0060 0.0255 0.1275)
+(-0.0030 0.0255 0.1275)
+(0.0000 0.0255 0.1275)
+(0.0030 0.0255 0.1275)
+(0.0060 0.0255 0.1275)
+(-0.0060 0.0285 0.1275)
+(-0.0030 0.0285 0.1275)
+(0.0000 0.0285 0.1275)
+(0.0030 0.0285 0.1275)
+(0.0060 0.0285 0.1275)
+(-0.0060 0.0315 0.1275)
+(-0.0030 0.0315 0.1275)
+(0.0000 0.0315 0.1275)
+(0.0030 0.0315 0.1275)
+(0.0060 0.0315 0.1275)
+(-0.0060 0.0345 0.1275)
+(-0.0030 0.0345 0.1275)
+(0.0000 0.0345 0.1275)
+(0.0030 0.0345 0.1275)
+(0.0060 0.0345 0.1275)
+(-0.0060 0.0375 0.1275)
+(-0.0030 0.0375 0.1275)
+(0.0000 0.0375 0.1275)
+(0.0030 0.0375 0.1275)
+(0.0060 0.0375 0.1275)
+(-0.0060 0.0405 0.1275)
+(-0.0030 0.0405 0.1275)
+(0.0000 0.0405 0.1275)
+(0.0030 0.0405 0.1275)
+(0.0060 0.0405 0.1275)
+(-0.0060 0.0435 0.1275)
+(-0.0030 0.0435 0.1275)
+(0.0000 0.0435 0.1275)
+(0.0030 0.0435 0.1275)
+(0.0060 0.0435 0.1275)
+(-0.0060 0.0465 0.1275)
+(-0.0030 0.0465 0.1275)
+(0.0000 0.0465 0.1275)
+(0.0030 0.0465 0.1275)
+(0.0060 0.0465 0.1275)
+(-0.0060 0.0495 0.1275)
+(-0.0030 0.0495 0.1275)
+(0.0000 0.0495 0.1275)
+(0.0030 0.0495 0.1275)
+(0.0060 0.0495 0.1275)
+(-0.0060 0.0525 0.1275)
+(-0.0030 0.0525 0.1275)
+(0.0000 0.0525 0.1275)
+(0.0030 0.0525 0.1275)
+(0.0060 0.0525 0.1275)
+(-0.0060 0.0555 0.1275)
+(-0.0030 0.0555 0.1275)
+(0.0000 0.0555 0.1275)
+(0.0030 0.0555 0.1275)
+(0.0060 0.0555 0.1275)
+(-0.0060 0.0585 0.1275)
+(-0.0030 0.0585 0.1275)
+(0.0000 0.0585 0.1275)
+(0.0030 0.0585 0.1275)
+(0.0060 0.0585 0.1275)
+(-0.0060 0.0615 0.1275)
+(-0.0030 0.0615 0.1275)
+(0.0000 0.0615 0.1275)
+(0.0030 0.0615 0.1275)
+(0.0060 0.0615 0.1275)
+(-0.0060 0.0645 0.1275)
+(-0.0030 0.0645 0.1275)
+(0.0000 0.0645 0.1275)
+(0.0030 0.0645 0.1275)
+(0.0060 0.0645 0.1275)
+(-0.0060 0.0675 0.1275)
+(-0.0030 0.0675 0.1275)
+(0.0000 0.0675 0.1275)
+(0.0030 0.0675 0.1275)
+(0.0060 0.0675 0.1275)
+(-0.0060 0.0705 0.1275)
+(-0.0030 0.0705 0.1275)
+(0.0000 0.0705 0.1275)
+(0.0030 0.0705 0.1275)
+(0.0060 0.0705 0.1275)
+(-0.0060 0.0735 0.1275)
+(-0.0030 0.0735 0.1275)
+(0.0000 0.0735 0.1275)
+(0.0030 0.0735 0.1275)
+(0.0060 0.0735 0.1275)
+(-0.0060 -0.0735 0.1305)
+(-0.0030 -0.0735 0.1305)
+(0.0000 -0.0735 0.1305)
+(0.0030 -0.0735 0.1305)
+(0.0060 -0.0735 0.1305)
+(-0.0060 -0.0705 0.1305)
+(-0.0030 -0.0705 0.1305)
+(0.0000 -0.0705 0.1305)
+(0.0030 -0.0705 0.1305)
+(0.0060 -0.0705 0.1305)
+(-0.0060 -0.0675 0.1305)
+(-0.0030 -0.0675 0.1305)
+(0.0000 -0.0675 0.1305)
+(0.0030 -0.0675 0.1305)
+(0.0060 -0.0675 0.1305)
+(-0.0060 -0.0645 0.1305)
+(-0.0030 -0.0645 0.1305)
+(0.0000 -0.0645 0.1305)
+(0.0030 -0.0645 0.1305)
+(0.0060 -0.0645 0.1305)
+(-0.0060 -0.0615 0.1305)
+(-0.0030 -0.0615 0.1305)
+(0.0000 -0.0615 0.1305)
+(0.0030 -0.0615 0.1305)
+(0.0060 -0.0615 0.1305)
+(-0.0060 -0.0585 0.1305)
+(-0.0030 -0.0585 0.1305)
+(0.0000 -0.0585 0.1305)
+(0.0030 -0.0585 0.1305)
+(0.0060 -0.0585 0.1305)
+(-0.0060 -0.0555 0.1305)
+(-0.0030 -0.0555 0.1305)
+(0.0000 -0.0555 0.1305)
+(0.0030 -0.0555 0.1305)
+(0.0060 -0.0555 0.1305)
+(-0.0060 -0.0525 0.1305)
+(-0.0030 -0.0525 0.1305)
+(0.0000 -0.0525 0.1305)
+(0.0030 -0.0525 0.1305)
+(0.0060 -0.0525 0.1305)
+(-0.0060 -0.0495 0.1305)
+(-0.0030 -0.0495 0.1305)
+(0.0000 -0.0495 0.1305)
+(0.0030 -0.0495 0.1305)
+(0.0060 -0.0495 0.1305)
+(-0.0060 -0.0465 0.1305)
+(-0.0030 -0.0465 0.1305)
+(0.0000 -0.0465 0.1305)
+(0.0030 -0.0465 0.1305)
+(0.0060 -0.0465 0.1305)
+(-0.0060 -0.0435 0.1305)
+(-0.0030 -0.0435 0.1305)
+(0.0000 -0.0435 0.1305)
+(0.0030 -0.0435 0.1305)
+(0.0060 -0.0435 0.1305)
+(-0.0060 -0.0405 0.1305)
+(-0.0030 -0.0405 0.1305)
+(0.0000 -0.0405 0.1305)
+(0.0030 -0.0405 0.1305)
+(0.0060 -0.0405 0.1305)
+(-0.0060 -0.0375 0.1305)
+(-0.0030 -0.0375 0.1305)
+(0.0000 -0.0375 0.1305)
+(0.0030 -0.0375 0.1305)
+(0.0060 -0.0375 0.1305)
+(-0.0060 -0.0345 0.1305)
+(-0.0030 -0.0345 0.1305)
+(0.0000 -0.0345 0.1305)
+(0.0030 -0.0345 0.1305)
+(0.0060 -0.0345 0.1305)
+(-0.0060 -0.0315 0.1305)
+(-0.0030 -0.0315 0.1305)
+(0.0000 -0.0315 0.1305)
+(0.0030 -0.0315 0.1305)
+(0.0060 -0.0315 0.1305)
+(-0.0060 -0.0285 0.1305)
+(-0.0030 -0.0285 0.1305)
+(0.0000 -0.0285 0.1305)
+(0.0030 -0.0285 0.1305)
+(0.0060 -0.0285 0.1305)
+(-0.0060 -0.0255 0.1305)
+(-0.0030 -0.0255 0.1305)
+(0.0000 -0.0255 0.1305)
+(0.0030 -0.0255 0.1305)
+(0.0060 -0.0255 0.1305)
+(-0.0060 -0.0225 0.1305)
+(-0.0030 -0.0225 0.1305)
+(0.0000 -0.0225 0.1305)
+(0.0030 -0.0225 0.1305)
+(0.0060 -0.0225 0.1305)
+(-0.0060 -0.0195 0.1305)
+(-0.0030 -0.0195 0.1305)
+(0.0000 -0.0195 0.1305)
+(0.0030 -0.0195 0.1305)
+(0.0060 -0.0195 0.1305)
+(-0.0060 -0.0165 0.1305)
+(-0.0030 -0.0165 0.1305)
+(0.0000 -0.0165 0.1305)
+(0.0030 -0.0165 0.1305)
+(0.0060 -0.0165 0.1305)
+(-0.0060 -0.0135 0.1305)
+(-0.0030 -0.0135 0.1305)
+(0.0000 -0.0135 0.1305)
+(0.0030 -0.0135 0.1305)
+(0.0060 -0.0135 0.1305)
+(-0.0060 -0.0105 0.1305)
+(-0.0030 -0.0105 0.1305)
+(0.0000 -0.0105 0.1305)
+(0.0030 -0.0105 0.1305)
+(0.0060 -0.0105 0.1305)
+(-0.0060 -0.0075 0.1305)
+(-0.0030 -0.0075 0.1305)
+(0.0000 -0.0075 0.1305)
+(0.0030 -0.0075 0.1305)
+(0.0060 -0.0075 0.1305)
+(-0.0060 -0.0045 0.1305)
+(-0.0030 -0.0045 0.1305)
+(0.0000 -0.0045 0.1305)
+(0.0030 -0.0045 0.1305)
+(0.0060 -0.0045 0.1305)
+(-0.0060 -0.0015 0.1305)
+(-0.0030 -0.0015 0.1305)
+(0.0000 -0.0015 0.1305)
+(0.0030 -0.0015 0.1305)
+(0.0060 -0.0015 0.1305)
+(-0.0060 0.0015 0.1305)
+(-0.0030 0.0015 0.1305)
+(0.0000 0.0015 0.1305)
+(0.0030 0.0015 0.1305)
+(0.0060 0.0015 0.1305)
+(-0.0060 0.0045 0.1305)
+(-0.0030 0.0045 0.1305)
+(0.0000 0.0045 0.1305)
+(0.0030 0.0045 0.1305)
+(0.0060 0.0045 0.1305)
+(-0.0060 0.0075 0.1305)
+(-0.0030 0.0075 0.1305)
+(0.0000 0.0075 0.1305)
+(0.0030 0.0075 0.1305)
+(0.0060 0.0075 0.1305)
+(-0.0060 0.0105 0.1305)
+(-0.0030 0.0105 0.1305)
+(0.0000 0.0105 0.1305)
+(0.0030 0.0105 0.1305)
+(0.0060 0.0105 0.1305)
+(-0.0060 0.0135 0.1305)
+(-0.0030 0.0135 0.1305)
+(0.0000 0.0135 0.1305)
+(0.0030 0.0135 0.1305)
+(0.0060 0.0135 0.1305)
+(-0.0060 0.0165 0.1305)
+(-0.0030 0.0165 0.1305)
+(0.0000 0.0165 0.1305)
+(0.0030 0.0165 0.1305)
+(0.0060 0.0165 0.1305)
+(-0.0060 0.0195 0.1305)
+(-0.0030 0.0195 0.1305)
+(0.0000 0.0195 0.1305)
+(0.0030 0.0195 0.1305)
+(0.0060 0.0195 0.1305)
+(-0.0060 0.0225 0.1305)
+(-0.0030 0.0225 0.1305)
+(0.0000 0.0225 0.1305)
+(0.0030 0.0225 0.1305)
+(0.0060 0.0225 0.1305)
+(-0.0060 0.0255 0.1305)
+(-0.0030 0.0255 0.1305)
+(0.0000 0.0255 0.1305)
+(0.0030 0.0255 0.1305)
+(0.0060 0.0255 0.1305)
+(-0.0060 0.0285 0.1305)
+(-0.0030 0.0285 0.1305)
+(0.0000 0.0285 0.1305)
+(0.0030 0.0285 0.1305)
+(0.0060 0.0285 0.1305)
+(-0.0060 0.0315 0.1305)
+(-0.0030 0.0315 0.1305)
+(0.0000 0.0315 0.1305)
+(0.0030 0.0315 0.1305)
+(0.0060 0.0315 0.1305)
+(-0.0060 0.0345 0.1305)
+(-0.0030 0.0345 0.1305)
+(0.0000 0.0345 0.1305)
+(0.0030 0.0345 0.1305)
+(0.0060 0.0345 0.1305)
+(-0.0060 0.0375 0.1305)
+(-0.0030 0.0375 0.1305)
+(0.0000 0.0375 0.1305)
+(0.0030 0.0375 0.1305)
+(0.0060 0.0375 0.1305)
+(-0.0060 0.0405 0.1305)
+(-0.0030 0.0405 0.1305)
+(0.0000 0.0405 0.1305)
+(0.0030 0.0405 0.1305)
+(0.0060 0.0405 0.1305)
+(-0.0060 0.0435 0.1305)
+(-0.0030 0.0435 0.1305)
+(0.0000 0.0435 0.1305)
+(0.0030 0.0435 0.1305)
+(0.0060 0.0435 0.1305)
+(-0.0060 0.0465 0.1305)
+(-0.0030 0.0465 0.1305)
+(0.0000 0.0465 0.1305)
+(0.0030 0.0465 0.1305)
+(0.0060 0.0465 0.1305)
+(-0.0060 0.0495 0.1305)
+(-0.0030 0.0495 0.1305)
+(0.0000 0.0495 0.1305)
+(0.0030 0.0495 0.1305)
+(0.0060 0.0495 0.1305)
+(-0.0060 0.0525 0.1305)
+(-0.0030 0.0525 0.1305)
+(0.0000 0.0525 0.1305)
+(0.0030 0.0525 0.1305)
+(0.0060 0.0525 0.1305)
+(-0.0060 0.0555 0.1305)
+(-0.0030 0.0555 0.1305)
+(0.0000 0.0555 0.1305)
+(0.0030 0.0555 0.1305)
+(0.0060 0.0555 0.1305)
+(-0.0060 0.0585 0.1305)
+(-0.0030 0.0585 0.1305)
+(0.0000 0.0585 0.1305)
+(0.0030 0.0585 0.1305)
+(0.0060 0.0585 0.1305)
+(-0.0060 0.0615 0.1305)
+(-0.0030 0.0615 0.1305)
+(0.0000 0.0615 0.1305)
+(0.0030 0.0615 0.1305)
+(0.0060 0.0615 0.1305)
+(-0.0060 0.0645 0.1305)
+(-0.0030 0.0645 0.1305)
+(0.0000 0.0645 0.1305)
+(0.0030 0.0645 0.1305)
+(0.0060 0.0645 0.1305)
+(-0.0060 0.0675 0.1305)
+(-0.0030 0.0675 0.1305)
+(0.0000 0.0675 0.1305)
+(0.0030 0.0675 0.1305)
+(0.0060 0.0675 0.1305)
+(-0.0060 0.0705 0.1305)
+(-0.0030 0.0705 0.1305)
+(0.0000 0.0705 0.1305)
+(0.0030 0.0705 0.1305)
+(0.0060 0.0705 0.1305)
+(-0.0060 0.0735 0.1305)
+(-0.0030 0.0735 0.1305)
+(0.0000 0.0735 0.1305)
+(0.0030 0.0735 0.1305)
+(0.0060 0.0735 0.1305)
+(-0.0060 -0.0735 0.1335)
+(-0.0030 -0.0735 0.1335)
+(0.0000 -0.0735 0.1335)
+(0.0030 -0.0735 0.1335)
+(0.0060 -0.0735 0.1335)
+(-0.0060 -0.0705 0.1335)
+(-0.0030 -0.0705 0.1335)
+(0.0000 -0.0705 0.1335)
+(0.0030 -0.0705 0.1335)
+(0.0060 -0.0705 0.1335)
+(-0.0060 -0.0675 0.1335)
+(-0.0030 -0.0675 0.1335)
+(0.0000 -0.0675 0.1335)
+(0.0030 -0.0675 0.1335)
+(0.0060 -0.0675 0.1335)
+(-0.0060 -0.0645 0.1335)
+(-0.0030 -0.0645 0.1335)
+(0.0000 -0.0645 0.1335)
+(0.0030 -0.0645 0.1335)
+(0.0060 -0.0645 0.1335)
+(-0.0060 -0.0615 0.1335)
+(-0.0030 -0.0615 0.1335)
+(0.0000 -0.0615 0.1335)
+(0.0030 -0.0615 0.1335)
+(0.0060 -0.0615 0.1335)
+(-0.0060 -0.0585 0.1335)
+(-0.0030 -0.0585 0.1335)
+(0.0000 -0.0585 0.1335)
+(0.0030 -0.0585 0.1335)
+(0.0060 -0.0585 0.1335)
+(-0.0060 -0.0555 0.1335)
+(-0.0030 -0.0555 0.1335)
+(0.0000 -0.0555 0.1335)
+(0.0030 -0.0555 0.1335)
+(0.0060 -0.0555 0.1335)
+(-0.0060 -0.0525 0.1335)
+(-0.0030 -0.0525 0.1335)
+(0.0000 -0.0525 0.1335)
+(0.0030 -0.0525 0.1335)
+(0.0060 -0.0525 0.1335)
+(-0.0060 -0.0495 0.1335)
+(-0.0030 -0.0495 0.1335)
+(0.0000 -0.0495 0.1335)
+(0.0030 -0.0495 0.1335)
+(0.0060 -0.0495 0.1335)
+(-0.0060 -0.0465 0.1335)
+(-0.0030 -0.0465 0.1335)
+(0.0000 -0.0465 0.1335)
+(0.0030 -0.0465 0.1335)
+(0.0060 -0.0465 0.1335)
+(-0.0060 -0.0435 0.1335)
+(-0.0030 -0.0435 0.1335)
+(0.0000 -0.0435 0.1335)
+(0.0030 -0.0435 0.1335)
+(0.0060 -0.0435 0.1335)
+(-0.0060 -0.0405 0.1335)
+(-0.0030 -0.0405 0.1335)
+(0.0000 -0.0405 0.1335)
+(0.0030 -0.0405 0.1335)
+(0.0060 -0.0405 0.1335)
+(-0.0060 -0.0375 0.1335)
+(-0.0030 -0.0375 0.1335)
+(0.0000 -0.0375 0.1335)
+(0.0030 -0.0375 0.1335)
+(0.0060 -0.0375 0.1335)
+(-0.0060 -0.0345 0.1335)
+(-0.0030 -0.0345 0.1335)
+(0.0000 -0.0345 0.1335)
+(0.0030 -0.0345 0.1335)
+(0.0060 -0.0345 0.1335)
+(-0.0060 -0.0315 0.1335)
+(-0.0030 -0.0315 0.1335)
+(0.0000 -0.0315 0.1335)
+(0.0030 -0.0315 0.1335)
+(0.0060 -0.0315 0.1335)
+(-0.0060 -0.0285 0.1335)
+(-0.0030 -0.0285 0.1335)
+(0.0000 -0.0285 0.1335)
+(0.0030 -0.0285 0.1335)
+(0.0060 -0.0285 0.1335)
+(-0.0060 -0.0255 0.1335)
+(-0.0030 -0.0255 0.1335)
+(0.0000 -0.0255 0.1335)
+(0.0030 -0.0255 0.1335)
+(0.0060 -0.0255 0.1335)
+(-0.0060 -0.0225 0.1335)
+(-0.0030 -0.0225 0.1335)
+(0.0000 -0.0225 0.1335)
+(0.0030 -0.0225 0.1335)
+(0.0060 -0.0225 0.1335)
+(-0.0060 -0.0195 0.1335)
+(-0.0030 -0.0195 0.1335)
+(0.0000 -0.0195 0.1335)
+(0.0030 -0.0195 0.1335)
+(0.0060 -0.0195 0.1335)
+(-0.0060 -0.0165 0.1335)
+(-0.0030 -0.0165 0.1335)
+(0.0000 -0.0165 0.1335)
+(0.0030 -0.0165 0.1335)
+(0.0060 -0.0165 0.1335)
+(-0.0060 -0.0135 0.1335)
+(-0.0030 -0.0135 0.1335)
+(0.0000 -0.0135 0.1335)
+(0.0030 -0.0135 0.1335)
+(0.0060 -0.0135 0.1335)
+(-0.0060 -0.0105 0.1335)
+(-0.0030 -0.0105 0.1335)
+(0.0000 -0.0105 0.1335)
+(0.0030 -0.0105 0.1335)
+(0.0060 -0.0105 0.1335)
+(-0.0060 -0.0075 0.1335)
+(-0.0030 -0.0075 0.1335)
+(0.0000 -0.0075 0.1335)
+(0.0030 -0.0075 0.1335)
+(0.0060 -0.0075 0.1335)
+(-0.0060 -0.0045 0.1335)
+(-0.0030 -0.0045 0.1335)
+(0.0000 -0.0045 0.1335)
+(0.0030 -0.0045 0.1335)
+(0.0060 -0.0045 0.1335)
+(-0.0060 -0.0015 0.1335)
+(-0.0030 -0.0015 0.1335)
+(0.0000 -0.0015 0.1335)
+(0.0030 -0.0015 0.1335)
+(0.0060 -0.0015 0.1335)
+(-0.0060 0.0015 0.1335)
+(-0.0030 0.0015 0.1335)
+(0.0000 0.0015 0.1335)
+(0.0030 0.0015 0.1335)
+(0.0060 0.0015 0.1335)
+(-0.0060 0.0045 0.1335)
+(-0.0030 0.0045 0.1335)
+(0.0000 0.0045 0.1335)
+(0.0030 0.0045 0.1335)
+(0.0060 0.0045 0.1335)
+(-0.0060 0.0075 0.1335)
+(-0.0030 0.0075 0.1335)
+(0.0000 0.0075 0.1335)
+(0.0030 0.0075 0.1335)
+(0.0060 0.0075 0.1335)
+(-0.0060 0.0105 0.1335)
+(-0.0030 0.0105 0.1335)
+(0.0000 0.0105 0.1335)
+(0.0030 0.0105 0.1335)
+(0.0060 0.0105 0.1335)
+(-0.0060 0.0135 0.1335)
+(-0.0030 0.0135 0.1335)
+(0.0000 0.0135 0.1335)
+(0.0030 0.0135 0.1335)
+(0.0060 0.0135 0.1335)
+(-0.0060 0.0165 0.1335)
+(-0.0030 0.0165 0.1335)
+(0.0000 0.0165 0.1335)
+(0.0030 0.0165 0.1335)
+(0.0060 0.0165 0.1335)
+(-0.0060 0.0195 0.1335)
+(-0.0030 0.0195 0.1335)
+(0.0000 0.0195 0.1335)
+(0.0030 0.0195 0.1335)
+(0.0060 0.0195 0.1335)
+(-0.0060 0.0225 0.1335)
+(-0.0030 0.0225 0.1335)
+(0.0000 0.0225 0.1335)
+(0.0030 0.0225 0.1335)
+(0.0060 0.0225 0.1335)
+(-0.0060 0.0255 0.1335)
+(-0.0030 0.0255 0.1335)
+(0.0000 0.0255 0.1335)
+(0.0030 0.0255 0.1335)
+(0.0060 0.0255 0.1335)
+(-0.0060 0.0285 0.1335)
+(-0.0030 0.0285 0.1335)
+(0.0000 0.0285 0.1335)
+(0.0030 0.0285 0.1335)
+(0.0060 0.0285 0.1335)
+(-0.0060 0.0315 0.1335)
+(-0.0030 0.0315 0.1335)
+(0.0000 0.0315 0.1335)
+(0.0030 0.0315 0.1335)
+(0.0060 0.0315 0.1335)
+(-0.0060 0.0345 0.1335)
+(-0.0030 0.0345 0.1335)
+(0.0000 0.0345 0.1335)
+(0.0030 0.0345 0.1335)
+(0.0060 0.0345 0.1335)
+(-0.0060 0.0375 0.1335)
+(-0.0030 0.0375 0.1335)
+(0.0000 0.0375 0.1335)
+(0.0030 0.0375 0.1335)
+(0.0060 0.0375 0.1335)
+(-0.0060 0.0405 0.1335)
+(-0.0030 0.0405 0.1335)
+(0.0000 0.0405 0.1335)
+(0.0030 0.0405 0.1335)
+(0.0060 0.0405 0.1335)
+(-0.0060 0.0435 0.1335)
+(-0.0030 0.0435 0.1335)
+(0.0000 0.0435 0.1335)
+(0.0030 0.0435 0.1335)
+(0.0060 0.0435 0.1335)
+(-0.0060 0.0465 0.1335)
+(-0.0030 0.0465 0.1335)
+(0.0000 0.0465 0.1335)
+(0.0030 0.0465 0.1335)
+(0.0060 0.0465 0.1335)
+(-0.0060 0.0495 0.1335)
+(-0.0030 0.0495 0.1335)
+(0.0000 0.0495 0.1335)
+(0.0030 0.0495 0.1335)
+(0.0060 0.0495 0.1335)
+(-0.0060 0.0525 0.1335)
+(-0.0030 0.0525 0.1335)
+(0.0000 0.0525 0.1335)
+(0.0030 0.0525 0.1335)
+(0.0060 0.0525 0.1335)
+(-0.0060 0.0555 0.1335)
+(-0.0030 0.0555 0.1335)
+(0.0000 0.0555 0.1335)
+(0.0030 0.0555 0.1335)
+(0.0060 0.0555 0.1335)
+(-0.0060 0.0585 0.1335)
+(-0.0030 0.0585 0.1335)
+(0.0000 0.0585 0.1335)
+(0.0030 0.0585 0.1335)
+(0.0060 0.0585 0.1335)
+(-0.0060 0.0615 0.1335)
+(-0.0030 0.0615 0.1335)
+(0.0000 0.0615 0.1335)
+(0.0030 0.0615 0.1335)
+(0.0060 0.0615 0.1335)
+(-0.0060 0.0645 0.1335)
+(-0.0030 0.0645 0.1335)
+(0.0000 0.0645 0.1335)
+(0.0030 0.0645 0.1335)
+(0.0060 0.0645 0.1335)
+(-0.0060 0.0675 0.1335)
+(-0.0030 0.0675 0.1335)
+(0.0000 0.0675 0.1335)
+(0.0030 0.0675 0.1335)
+(0.0060 0.0675 0.1335)
+(-0.0060 0.0705 0.1335)
+(-0.0030 0.0705 0.1335)
+(0.0000 0.0705 0.1335)
+(0.0030 0.0705 0.1335)
+(0.0060 0.0705 0.1335)
+(-0.0060 0.0735 0.1335)
+(-0.0030 0.0735 0.1335)
+(0.0000 0.0735 0.1335)
+(0.0030 0.0735 0.1335)
+(0.0060 0.0735 0.1335)
+(-0.0060 -0.0735 0.1365)
+(-0.0030 -0.0735 0.1365)
+(0.0000 -0.0735 0.1365)
+(0.0030 -0.0735 0.1365)
+(0.0060 -0.0735 0.1365)
+(-0.0060 -0.0705 0.1365)
+(-0.0030 -0.0705 0.1365)
+(0.0000 -0.0705 0.1365)
+(0.0030 -0.0705 0.1365)
+(0.0060 -0.0705 0.1365)
+(-0.0060 -0.0675 0.1365)
+(-0.0030 -0.0675 0.1365)
+(0.0000 -0.0675 0.1365)
+(0.0030 -0.0675 0.1365)
+(0.0060 -0.0675 0.1365)
+(-0.0060 -0.0645 0.1365)
+(-0.0030 -0.0645 0.1365)
+(0.0000 -0.0645 0.1365)
+(0.0030 -0.0645 0.1365)
+(0.0060 -0.0645 0.1365)
+(-0.0060 -0.0615 0.1365)
+(-0.0030 -0.0615 0.1365)
+(0.0000 -0.0615 0.1365)
+(0.0030 -0.0615 0.1365)
+(0.0060 -0.0615 0.1365)
+(-0.0060 -0.0585 0.1365)
+(-0.0030 -0.0585 0.1365)
+(0.0000 -0.0585 0.1365)
+(0.0030 -0.0585 0.1365)
+(0.0060 -0.0585 0.1365)
+(-0.0060 -0.0555 0.1365)
+(-0.0030 -0.0555 0.1365)
+(0.0000 -0.0555 0.1365)
+(0.0030 -0.0555 0.1365)
+(0.0060 -0.0555 0.1365)
+(-0.0060 -0.0525 0.1365)
+(-0.0030 -0.0525 0.1365)
+(0.0000 -0.0525 0.1365)
+(0.0030 -0.0525 0.1365)
+(0.0060 -0.0525 0.1365)
+(-0.0060 -0.0495 0.1365)
+(-0.0030 -0.0495 0.1365)
+(0.0000 -0.0495 0.1365)
+(0.0030 -0.0495 0.1365)
+(0.0060 -0.0495 0.1365)
+(-0.0060 -0.0465 0.1365)
+(-0.0030 -0.0465 0.1365)
+(0.0000 -0.0465 0.1365)
+(0.0030 -0.0465 0.1365)
+(0.0060 -0.0465 0.1365)
+(-0.0060 -0.0435 0.1365)
+(-0.0030 -0.0435 0.1365)
+(0.0000 -0.0435 0.1365)
+(0.0030 -0.0435 0.1365)
+(0.0060 -0.0435 0.1365)
+(-0.0060 -0.0405 0.1365)
+(-0.0030 -0.0405 0.1365)
+(0.0000 -0.0405 0.1365)
+(0.0030 -0.0405 0.1365)
+(0.0060 -0.0405 0.1365)
+(-0.0060 -0.0375 0.1365)
+(-0.0030 -0.0375 0.1365)
+(0.0000 -0.0375 0.1365)
+(0.0030 -0.0375 0.1365)
+(0.0060 -0.0375 0.1365)
+(-0.0060 -0.0345 0.1365)
+(-0.0030 -0.0345 0.1365)
+(0.0000 -0.0345 0.1365)
+(0.0030 -0.0345 0.1365)
+(0.0060 -0.0345 0.1365)
+(-0.0060 -0.0315 0.1365)
+(-0.0030 -0.0315 0.1365)
+(0.0000 -0.0315 0.1365)
+(0.0030 -0.0315 0.1365)
+(0.0060 -0.0315 0.1365)
+(-0.0060 -0.0285 0.1365)
+(-0.0030 -0.0285 0.1365)
+(0.0000 -0.0285 0.1365)
+(0.0030 -0.0285 0.1365)
+(0.0060 -0.0285 0.1365)
+(-0.0060 -0.0255 0.1365)
+(-0.0030 -0.0255 0.1365)
+(0.0000 -0.0255 0.1365)
+(0.0030 -0.0255 0.1365)
+(0.0060 -0.0255 0.1365)
+(-0.0060 -0.0225 0.1365)
+(-0.0030 -0.0225 0.1365)
+(0.0000 -0.0225 0.1365)
+(0.0030 -0.0225 0.1365)
+(0.0060 -0.0225 0.1365)
+(-0.0060 -0.0195 0.1365)
+(-0.0030 -0.0195 0.1365)
+(0.0000 -0.0195 0.1365)
+(0.0030 -0.0195 0.1365)
+(0.0060 -0.0195 0.1365)
+(-0.0060 -0.0165 0.1365)
+(-0.0030 -0.0165 0.1365)
+(0.0000 -0.0165 0.1365)
+(0.0030 -0.0165 0.1365)
+(0.0060 -0.0165 0.1365)
+(-0.0060 -0.0135 0.1365)
+(-0.0030 -0.0135 0.1365)
+(0.0000 -0.0135 0.1365)
+(0.0030 -0.0135 0.1365)
+(0.0060 -0.0135 0.1365)
+(-0.0060 -0.0105 0.1365)
+(-0.0030 -0.0105 0.1365)
+(0.0000 -0.0105 0.1365)
+(0.0030 -0.0105 0.1365)
+(0.0060 -0.0105 0.1365)
+(-0.0060 -0.0075 0.1365)
+(-0.0030 -0.0075 0.1365)
+(0.0000 -0.0075 0.1365)
+(0.0030 -0.0075 0.1365)
+(0.0060 -0.0075 0.1365)
+(-0.0060 -0.0045 0.1365)
+(-0.0030 -0.0045 0.1365)
+(0.0000 -0.0045 0.1365)
+(0.0030 -0.0045 0.1365)
+(0.0060 -0.0045 0.1365)
+(-0.0060 -0.0015 0.1365)
+(-0.0030 -0.0015 0.1365)
+(0.0000 -0.0015 0.1365)
+(0.0030 -0.0015 0.1365)
+(0.0060 -0.0015 0.1365)
+(-0.0060 0.0015 0.1365)
+(-0.0030 0.0015 0.1365)
+(0.0000 0.0015 0.1365)
+(0.0030 0.0015 0.1365)
+(0.0060 0.0015 0.1365)
+(-0.0060 0.0045 0.1365)
+(-0.0030 0.0045 0.1365)
+(0.0000 0.0045 0.1365)
+(0.0030 0.0045 0.1365)
+(0.0060 0.0045 0.1365)
+(-0.0060 0.0075 0.1365)
+(-0.0030 0.0075 0.1365)
+(0.0000 0.0075 0.1365)
+(0.0030 0.0075 0.1365)
+(0.0060 0.0075 0.1365)
+(-0.0060 0.0105 0.1365)
+(-0.0030 0.0105 0.1365)
+(0.0000 0.0105 0.1365)
+(0.0030 0.0105 0.1365)
+(0.0060 0.0105 0.1365)
+(-0.0060 0.0135 0.1365)
+(-0.0030 0.0135 0.1365)
+(0.0000 0.0135 0.1365)
+(0.0030 0.0135 0.1365)
+(0.0060 0.0135 0.1365)
+(-0.0060 0.0165 0.1365)
+(-0.0030 0.0165 0.1365)
+(0.0000 0.0165 0.1365)
+(0.0030 0.0165 0.1365)
+(0.0060 0.0165 0.1365)
+(-0.0060 0.0195 0.1365)
+(-0.0030 0.0195 0.1365)
+(0.0000 0.0195 0.1365)
+(0.0030 0.0195 0.1365)
+(0.0060 0.0195 0.1365)
+(-0.0060 0.0225 0.1365)
+(-0.0030 0.0225 0.1365)
+(0.0000 0.0225 0.1365)
+(0.0030 0.0225 0.1365)
+(0.0060 0.0225 0.1365)
+(-0.0060 0.0255 0.1365)
+(-0.0030 0.0255 0.1365)
+(0.0000 0.0255 0.1365)
+(0.0030 0.0255 0.1365)
+(0.0060 0.0255 0.1365)
+(-0.0060 0.0285 0.1365)
+(-0.0030 0.0285 0.1365)
+(0.0000 0.0285 0.1365)
+(0.0030 0.0285 0.1365)
+(0.0060 0.0285 0.1365)
+(-0.0060 0.0315 0.1365)
+(-0.0030 0.0315 0.1365)
+(0.0000 0.0315 0.1365)
+(0.0030 0.0315 0.1365)
+(0.0060 0.0315 0.1365)
+(-0.0060 0.0345 0.1365)
+(-0.0030 0.0345 0.1365)
+(0.0000 0.0345 0.1365)
+(0.0030 0.0345 0.1365)
+(0.0060 0.0345 0.1365)
+(-0.0060 0.0375 0.1365)
+(-0.0030 0.0375 0.1365)
+(0.0000 0.0375 0.1365)
+(0.0030 0.0375 0.1365)
+(0.0060 0.0375 0.1365)
+(-0.0060 0.0405 0.1365)
+(-0.0030 0.0405 0.1365)
+(0.0000 0.0405 0.1365)
+(0.0030 0.0405 0.1365)
+(0.0060 0.0405 0.1365)
+(-0.0060 0.0435 0.1365)
+(-0.0030 0.0435 0.1365)
+(0.0000 0.0435 0.1365)
+(0.0030 0.0435 0.1365)
+(0.0060 0.0435 0.1365)
+(-0.0060 0.0465 0.1365)
+(-0.0030 0.0465 0.1365)
+(0.0000 0.0465 0.1365)
+(0.0030 0.0465 0.1365)
+(0.0060 0.0465 0.1365)
+(-0.0060 0.0495 0.1365)
+(-0.0030 0.0495 0.1365)
+(0.0000 0.0495 0.1365)
+(0.0030 0.0495 0.1365)
+(0.0060 0.0495 0.1365)
+(-0.0060 0.0525 0.1365)
+(-0.0030 0.0525 0.1365)
+(0.0000 0.0525 0.1365)
+(0.0030 0.0525 0.1365)
+(0.0060 0.0525 0.1365)
+(-0.0060 0.0555 0.1365)
+(-0.0030 0.0555 0.1365)
+(0.0000 0.0555 0.1365)
+(0.0030 0.0555 0.1365)
+(0.0060 0.0555 0.1365)
+(-0.0060 0.0585 0.1365)
+(-0.0030 0.0585 0.1365)
+(0.0000 0.0585 0.1365)
+(0.0030 0.0585 0.1365)
+(0.0060 0.0585 0.1365)
+(-0.0060 0.0615 0.1365)
+(-0.0030 0.0615 0.1365)
+(0.0000 0.0615 0.1365)
+(0.0030 0.0615 0.1365)
+(0.0060 0.0615 0.1365)
+(-0.0060 0.0645 0.1365)
+(-0.0030 0.0645 0.1365)
+(0.0000 0.0645 0.1365)
+(0.0030 0.0645 0.1365)
+(0.0060 0.0645 0.1365)
+(-0.0060 0.0675 0.1365)
+(-0.0030 0.0675 0.1365)
+(0.0000 0.0675 0.1365)
+(0.0030 0.0675 0.1365)
+(0.0060 0.0675 0.1365)
+(-0.0060 0.0705 0.1365)
+(-0.0030 0.0705 0.1365)
+(0.0000 0.0705 0.1365)
+(0.0030 0.0705 0.1365)
+(0.0060 0.0705 0.1365)
+(-0.0060 0.0735 0.1365)
+(-0.0030 0.0735 0.1365)
+(0.0000 0.0735 0.1365)
+(0.0030 0.0735 0.1365)
+(0.0060 0.0735 0.1365)
+(-0.0060 -0.0735 0.1395)
+(-0.0030 -0.0735 0.1395)
+(0.0000 -0.0735 0.1395)
+(0.0030 -0.0735 0.1395)
+(0.0060 -0.0735 0.1395)
+(-0.0060 -0.0705 0.1395)
+(-0.0030 -0.0705 0.1395)
+(0.0000 -0.0705 0.1395)
+(0.0030 -0.0705 0.1395)
+(0.0060 -0.0705 0.1395)
+(-0.0060 -0.0675 0.1395)
+(-0.0030 -0.0675 0.1395)
+(0.0000 -0.0675 0.1395)
+(0.0030 -0.0675 0.1395)
+(0.0060 -0.0675 0.1395)
+(-0.0060 -0.0645 0.1395)
+(-0.0030 -0.0645 0.1395)
+(0.0000 -0.0645 0.1395)
+(0.0030 -0.0645 0.1395)
+(0.0060 -0.0645 0.1395)
+(-0.0060 -0.0615 0.1395)
+(-0.0030 -0.0615 0.1395)
+(0.0000 -0.0615 0.1395)
+(0.0030 -0.0615 0.1395)
+(0.0060 -0.0615 0.1395)
+(-0.0060 -0.0585 0.1395)
+(-0.0030 -0.0585 0.1395)
+(0.0000 -0.0585 0.1395)
+(0.0030 -0.0585 0.1395)
+(0.0060 -0.0585 0.1395)
+(-0.0060 -0.0555 0.1395)
+(-0.0030 -0.0555 0.1395)
+(0.0000 -0.0555 0.1395)
+(0.0030 -0.0555 0.1395)
+(0.0060 -0.0555 0.1395)
+(-0.0060 -0.0525 0.1395)
+(-0.0030 -0.0525 0.1395)
+(0.0000 -0.0525 0.1395)
+(0.0030 -0.0525 0.1395)
+(0.0060 -0.0525 0.1395)
+(-0.0060 -0.0495 0.1395)
+(-0.0030 -0.0495 0.1395)
+(0.0000 -0.0495 0.1395)
+(0.0030 -0.0495 0.1395)
+(0.0060 -0.0495 0.1395)
+(-0.0060 -0.0465 0.1395)
+(-0.0030 -0.0465 0.1395)
+(0.0000 -0.0465 0.1395)
+(0.0030 -0.0465 0.1395)
+(0.0060 -0.0465 0.1395)
+(-0.0060 -0.0435 0.1395)
+(-0.0030 -0.0435 0.1395)
+(0.0000 -0.0435 0.1395)
+(0.0030 -0.0435 0.1395)
+(0.0060 -0.0435 0.1395)
+(-0.0060 -0.0405 0.1395)
+(-0.0030 -0.0405 0.1395)
+(0.0000 -0.0405 0.1395)
+(0.0030 -0.0405 0.1395)
+(0.0060 -0.0405 0.1395)
+(-0.0060 -0.0375 0.1395)
+(-0.0030 -0.0375 0.1395)
+(0.0000 -0.0375 0.1395)
+(0.0030 -0.0375 0.1395)
+(0.0060 -0.0375 0.1395)
+(-0.0060 -0.0345 0.1395)
+(-0.0030 -0.0345 0.1395)
+(0.0000 -0.0345 0.1395)
+(0.0030 -0.0345 0.1395)
+(0.0060 -0.0345 0.1395)
+(-0.0060 -0.0315 0.1395)
+(-0.0030 -0.0315 0.1395)
+(0.0000 -0.0315 0.1395)
+(0.0030 -0.0315 0.1395)
+(0.0060 -0.0315 0.1395)
+(-0.0060 -0.0285 0.1395)
+(-0.0030 -0.0285 0.1395)
+(0.0000 -0.0285 0.1395)
+(0.0030 -0.0285 0.1395)
+(0.0060 -0.0285 0.1395)
+(-0.0060 -0.0255 0.1395)
+(-0.0030 -0.0255 0.1395)
+(0.0000 -0.0255 0.1395)
+(0.0030 -0.0255 0.1395)
+(0.0060 -0.0255 0.1395)
+(-0.0060 -0.0225 0.1395)
+(-0.0030 -0.0225 0.1395)
+(0.0000 -0.0225 0.1395)
+(0.0030 -0.0225 0.1395)
+(0.0060 -0.0225 0.1395)
+(-0.0060 -0.0195 0.1395)
+(-0.0030 -0.0195 0.1395)
+(0.0000 -0.0195 0.1395)
+(0.0030 -0.0195 0.1395)
+(0.0060 -0.0195 0.1395)
+(-0.0060 -0.0165 0.1395)
+(-0.0030 -0.0165 0.1395)
+(0.0000 -0.0165 0.1395)
+(0.0030 -0.0165 0.1395)
+(0.0060 -0.0165 0.1395)
+(-0.0060 -0.0135 0.1395)
+(-0.0030 -0.0135 0.1395)
+(0.0000 -0.0135 0.1395)
+(0.0030 -0.0135 0.1395)
+(0.0060 -0.0135 0.1395)
+(-0.0060 -0.0105 0.1395)
+(-0.0030 -0.0105 0.1395)
+(0.0000 -0.0105 0.1395)
+(0.0030 -0.0105 0.1395)
+(0.0060 -0.0105 0.1395)
+(-0.0060 -0.0075 0.1395)
+(-0.0030 -0.0075 0.1395)
+(0.0000 -0.0075 0.1395)
+(0.0030 -0.0075 0.1395)
+(0.0060 -0.0075 0.1395)
+(-0.0060 -0.0045 0.1395)
+(-0.0030 -0.0045 0.1395)
+(0.0000 -0.0045 0.1395)
+(0.0030 -0.0045 0.1395)
+(0.0060 -0.0045 0.1395)
+(-0.0060 -0.0015 0.1395)
+(-0.0030 -0.0015 0.1395)
+(0.0000 -0.0015 0.1395)
+(0.0030 -0.0015 0.1395)
+(0.0060 -0.0015 0.1395)
+(-0.0060 0.0015 0.1395)
+(-0.0030 0.0015 0.1395)
+(0.0000 0.0015 0.1395)
+(0.0030 0.0015 0.1395)
+(0.0060 0.0015 0.1395)
+(-0.0060 0.0045 0.1395)
+(-0.0030 0.0045 0.1395)
+(0.0000 0.0045 0.1395)
+(0.0030 0.0045 0.1395)
+(0.0060 0.0045 0.1395)
+(-0.0060 0.0075 0.1395)
+(-0.0030 0.0075 0.1395)
+(0.0000 0.0075 0.1395)
+(0.0030 0.0075 0.1395)
+(0.0060 0.0075 0.1395)
+(-0.0060 0.0105 0.1395)
+(-0.0030 0.0105 0.1395)
+(0.0000 0.0105 0.1395)
+(0.0030 0.0105 0.1395)
+(0.0060 0.0105 0.1395)
+(-0.0060 0.0135 0.1395)
+(-0.0030 0.0135 0.1395)
+(0.0000 0.0135 0.1395)
+(0.0030 0.0135 0.1395)
+(0.0060 0.0135 0.1395)
+(-0.0060 0.0165 0.1395)
+(-0.0030 0.0165 0.1395)
+(0.0000 0.0165 0.1395)
+(0.0030 0.0165 0.1395)
+(0.0060 0.0165 0.1395)
+(-0.0060 0.0195 0.1395)
+(-0.0030 0.0195 0.1395)
+(0.0000 0.0195 0.1395)
+(0.0030 0.0195 0.1395)
+(0.0060 0.0195 0.1395)
+(-0.0060 0.0225 0.1395)
+(-0.0030 0.0225 0.1395)
+(0.0000 0.0225 0.1395)
+(0.0030 0.0225 0.1395)
+(0.0060 0.0225 0.1395)
+(-0.0060 0.0255 0.1395)
+(-0.0030 0.0255 0.1395)
+(0.0000 0.0255 0.1395)
+(0.0030 0.0255 0.1395)
+(0.0060 0.0255 0.1395)
+(-0.0060 0.0285 0.1395)
+(-0.0030 0.0285 0.1395)
+(0.0000 0.0285 0.1395)
+(0.0030 0.0285 0.1395)
+(0.0060 0.0285 0.1395)
+(-0.0060 0.0315 0.1395)
+(-0.0030 0.0315 0.1395)
+(0.0000 0.0315 0.1395)
+(0.0030 0.0315 0.1395)
+(0.0060 0.0315 0.1395)
+(-0.0060 0.0345 0.1395)
+(-0.0030 0.0345 0.1395)
+(0.0000 0.0345 0.1395)
+(0.0030 0.0345 0.1395)
+(0.0060 0.0345 0.1395)
+(-0.0060 0.0375 0.1395)
+(-0.0030 0.0375 0.1395)
+(0.0000 0.0375 0.1395)
+(0.0030 0.0375 0.1395)
+(0.0060 0.0375 0.1395)
+(-0.0060 0.0405 0.1395)
+(-0.0030 0.0405 0.1395)
+(0.0000 0.0405 0.1395)
+(0.0030 0.0405 0.1395)
+(0.0060 0.0405 0.1395)
+(-0.0060 0.0435 0.1395)
+(-0.0030 0.0435 0.1395)
+(0.0000 0.0435 0.1395)
+(0.0030 0.0435 0.1395)
+(0.0060 0.0435 0.1395)
+(-0.0060 0.0465 0.1395)
+(-0.0030 0.0465 0.1395)
+(0.0000 0.0465 0.1395)
+(0.0030 0.0465 0.1395)
+(0.0060 0.0465 0.1395)
+(-0.0060 0.0495 0.1395)
+(-0.0030 0.0495 0.1395)
+(0.0000 0.0495 0.1395)
+(0.0030 0.0495 0.1395)
+(0.0060 0.0495 0.1395)
+(-0.0060 0.0525 0.1395)
+(-0.0030 0.0525 0.1395)
+(0.0000 0.0525 0.1395)
+(0.0030 0.0525 0.1395)
+(0.0060 0.0525 0.1395)
+(-0.0060 0.0555 0.1395)
+(-0.0030 0.0555 0.1395)
+(0.0000 0.0555 0.1395)
+(0.0030 0.0555 0.1395)
+(0.0060 0.0555 0.1395)
+(-0.0060 0.0585 0.1395)
+(-0.0030 0.0585 0.1395)
+(0.0000 0.0585 0.1395)
+(0.0030 0.0585 0.1395)
+(0.0060 0.0585 0.1395)
+(-0.0060 0.0615 0.1395)
+(-0.0030 0.0615 0.1395)
+(0.0000 0.0615 0.1395)
+(0.0030 0.0615 0.1395)
+(0.0060 0.0615 0.1395)
+(-0.0060 0.0645 0.1395)
+(-0.0030 0.0645 0.1395)
+(0.0000 0.0645 0.1395)
+(0.0030 0.0645 0.1395)
+(0.0060 0.0645 0.1395)
+(-0.0060 0.0675 0.1395)
+(-0.0030 0.0675 0.1395)
+(0.0000 0.0675 0.1395)
+(0.0030 0.0675 0.1395)
+(0.0060 0.0675 0.1395)
+(-0.0060 0.0705 0.1395)
+(-0.0030 0.0705 0.1395)
+(0.0000 0.0705 0.1395)
+(0.0030 0.0705 0.1395)
+(0.0060 0.0705 0.1395)
+(-0.0060 0.0735 0.1395)
+(-0.0030 0.0735 0.1395)
+(0.0000 0.0735 0.1395)
+(0.0030 0.0735 0.1395)
+(0.0060 0.0735 0.1395)
+(-0.0060 -0.0735 0.1425)
+(-0.0030 -0.0735 0.1425)
+(0.0000 -0.0735 0.1425)
+(0.0030 -0.0735 0.1425)
+(0.0060 -0.0735 0.1425)
+(-0.0060 -0.0705 0.1425)
+(-0.0030 -0.0705 0.1425)
+(0.0000 -0.0705 0.1425)
+(0.0030 -0.0705 0.1425)
+(0.0060 -0.0705 0.1425)
+(-0.0060 -0.0675 0.1425)
+(-0.0030 -0.0675 0.1425)
+(0.0000 -0.0675 0.1425)
+(0.0030 -0.0675 0.1425)
+(0.0060 -0.0675 0.1425)
+(-0.0060 -0.0645 0.1425)
+(-0.0030 -0.0645 0.1425)
+(0.0000 -0.0645 0.1425)
+(0.0030 -0.0645 0.1425)
+(0.0060 -0.0645 0.1425)
+(-0.0060 -0.0615 0.1425)
+(-0.0030 -0.0615 0.1425)
+(0.0000 -0.0615 0.1425)
+(0.0030 -0.0615 0.1425)
+(0.0060 -0.0615 0.1425)
+(-0.0060 -0.0585 0.1425)
+(-0.0030 -0.0585 0.1425)
+(0.0000 -0.0585 0.1425)
+(0.0030 -0.0585 0.1425)
+(0.0060 -0.0585 0.1425)
+(-0.0060 -0.0555 0.1425)
+(-0.0030 -0.0555 0.1425)
+(0.0000 -0.0555 0.1425)
+(0.0030 -0.0555 0.1425)
+(0.0060 -0.0555 0.1425)
+(-0.0060 -0.0525 0.1425)
+(-0.0030 -0.0525 0.1425)
+(0.0000 -0.0525 0.1425)
+(0.0030 -0.0525 0.1425)
+(0.0060 -0.0525 0.1425)
+(-0.0060 -0.0495 0.1425)
+(-0.0030 -0.0495 0.1425)
+(0.0000 -0.0495 0.1425)
+(0.0030 -0.0495 0.1425)
+(0.0060 -0.0495 0.1425)
+(-0.0060 -0.0465 0.1425)
+(-0.0030 -0.0465 0.1425)
+(0.0000 -0.0465 0.1425)
+(0.0030 -0.0465 0.1425)
+(0.0060 -0.0465 0.1425)
+(-0.0060 -0.0435 0.1425)
+(-0.0030 -0.0435 0.1425)
+(0.0000 -0.0435 0.1425)
+(0.0030 -0.0435 0.1425)
+(0.0060 -0.0435 0.1425)
+(-0.0060 -0.0405 0.1425)
+(-0.0030 -0.0405 0.1425)
+(0.0000 -0.0405 0.1425)
+(0.0030 -0.0405 0.1425)
+(0.0060 -0.0405 0.1425)
+(-0.0060 -0.0375 0.1425)
+(-0.0030 -0.0375 0.1425)
+(0.0000 -0.0375 0.1425)
+(0.0030 -0.0375 0.1425)
+(0.0060 -0.0375 0.1425)
+(-0.0060 -0.0345 0.1425)
+(-0.0030 -0.0345 0.1425)
+(0.0000 -0.0345 0.1425)
+(0.0030 -0.0345 0.1425)
+(0.0060 -0.0345 0.1425)
+(-0.0060 -0.0315 0.1425)
+(-0.0030 -0.0315 0.1425)
+(0.0000 -0.0315 0.1425)
+(0.0030 -0.0315 0.1425)
+(0.0060 -0.0315 0.1425)
+(-0.0060 -0.0285 0.1425)
+(-0.0030 -0.0285 0.1425)
+(0.0000 -0.0285 0.1425)
+(0.0030 -0.0285 0.1425)
+(0.0060 -0.0285 0.1425)
+(-0.0060 -0.0255 0.1425)
+(-0.0030 -0.0255 0.1425)
+(0.0000 -0.0255 0.1425)
+(0.0030 -0.0255 0.1425)
+(0.0060 -0.0255 0.1425)
+(-0.0060 -0.0225 0.1425)
+(-0.0030 -0.0225 0.1425)
+(0.0000 -0.0225 0.1425)
+(0.0030 -0.0225 0.1425)
+(0.0060 -0.0225 0.1425)
+(-0.0060 -0.0195 0.1425)
+(-0.0030 -0.0195 0.1425)
+(0.0000 -0.0195 0.1425)
+(0.0030 -0.0195 0.1425)
+(0.0060 -0.0195 0.1425)
+(-0.0060 -0.0165 0.1425)
+(-0.0030 -0.0165 0.1425)
+(0.0000 -0.0165 0.1425)
+(0.0030 -0.0165 0.1425)
+(0.0060 -0.0165 0.1425)
+(-0.0060 -0.0135 0.1425)
+(-0.0030 -0.0135 0.1425)
+(0.0000 -0.0135 0.1425)
+(0.0030 -0.0135 0.1425)
+(0.0060 -0.0135 0.1425)
+(-0.0060 -0.0105 0.1425)
+(-0.0030 -0.0105 0.1425)
+(0.0000 -0.0105 0.1425)
+(0.0030 -0.0105 0.1425)
+(0.0060 -0.0105 0.1425)
+(-0.0060 -0.0075 0.1425)
+(-0.0030 -0.0075 0.1425)
+(0.0000 -0.0075 0.1425)
+(0.0030 -0.0075 0.1425)
+(0.0060 -0.0075 0.1425)
+(-0.0060 -0.0045 0.1425)
+(-0.0030 -0.0045 0.1425)
+(0.0000 -0.0045 0.1425)
+(0.0030 -0.0045 0.1425)
+(0.0060 -0.0045 0.1425)
+(-0.0060 -0.0015 0.1425)
+(-0.0030 -0.0015 0.1425)
+(0.0000 -0.0015 0.1425)
+(0.0030 -0.0015 0.1425)
+(0.0060 -0.0015 0.1425)
+(-0.0060 0.0015 0.1425)
+(-0.0030 0.0015 0.1425)
+(0.0000 0.0015 0.1425)
+(0.0030 0.0015 0.1425)
+(0.0060 0.0015 0.1425)
+(-0.0060 0.0045 0.1425)
+(-0.0030 0.0045 0.1425)
+(0.0000 0.0045 0.1425)
+(0.0030 0.0045 0.1425)
+(0.0060 0.0045 0.1425)
+(-0.0060 0.0075 0.1425)
+(-0.0030 0.0075 0.1425)
+(0.0000 0.0075 0.1425)
+(0.0030 0.0075 0.1425)
+(0.0060 0.0075 0.1425)
+(-0.0060 0.0105 0.1425)
+(-0.0030 0.0105 0.1425)
+(0.0000 0.0105 0.1425)
+(0.0030 0.0105 0.1425)
+(0.0060 0.0105 0.1425)
+(-0.0060 0.0135 0.1425)
+(-0.0030 0.0135 0.1425)
+(0.0000 0.0135 0.1425)
+(0.0030 0.0135 0.1425)
+(0.0060 0.0135 0.1425)
+(-0.0060 0.0165 0.1425)
+(-0.0030 0.0165 0.1425)
+(0.0000 0.0165 0.1425)
+(0.0030 0.0165 0.1425)
+(0.0060 0.0165 0.1425)
+(-0.0060 0.0195 0.1425)
+(-0.0030 0.0195 0.1425)
+(0.0000 0.0195 0.1425)
+(0.0030 0.0195 0.1425)
+(0.0060 0.0195 0.1425)
+(-0.0060 0.0225 0.1425)
+(-0.0030 0.0225 0.1425)
+(0.0000 0.0225 0.1425)
+(0.0030 0.0225 0.1425)
+(0.0060 0.0225 0.1425)
+(-0.0060 0.0255 0.1425)
+(-0.0030 0.0255 0.1425)
+(0.0000 0.0255 0.1425)
+(0.0030 0.0255 0.1425)
+(0.0060 0.0255 0.1425)
+(-0.0060 0.0285 0.1425)
+(-0.0030 0.0285 0.1425)
+(0.0000 0.0285 0.1425)
+(0.0030 0.0285 0.1425)
+(0.0060 0.0285 0.1425)
+(-0.0060 0.0315 0.1425)
+(-0.0030 0.0315 0.1425)
+(0.0000 0.0315 0.1425)
+(0.0030 0.0315 0.1425)
+(0.0060 0.0315 0.1425)
+(-0.0060 0.0345 0.1425)
+(-0.0030 0.0345 0.1425)
+(0.0000 0.0345 0.1425)
+(0.0030 0.0345 0.1425)
+(0.0060 0.0345 0.1425)
+(-0.0060 0.0375 0.1425)
+(-0.0030 0.0375 0.1425)
+(0.0000 0.0375 0.1425)
+(0.0030 0.0375 0.1425)
+(0.0060 0.0375 0.1425)
+(-0.0060 0.0405 0.1425)
+(-0.0030 0.0405 0.1425)
+(0.0000 0.0405 0.1425)
+(0.0030 0.0405 0.1425)
+(0.0060 0.0405 0.1425)
+(-0.0060 0.0435 0.1425)
+(-0.0030 0.0435 0.1425)
+(0.0000 0.0435 0.1425)
+(0.0030 0.0435 0.1425)
+(0.0060 0.0435 0.1425)
+(-0.0060 0.0465 0.1425)
+(-0.0030 0.0465 0.1425)
+(0.0000 0.0465 0.1425)
+(0.0030 0.0465 0.1425)
+(0.0060 0.0465 0.1425)
+(-0.0060 0.0495 0.1425)
+(-0.0030 0.0495 0.1425)
+(0.0000 0.0495 0.1425)
+(0.0030 0.0495 0.1425)
+(0.0060 0.0495 0.1425)
+(-0.0060 0.0525 0.1425)
+(-0.0030 0.0525 0.1425)
+(0.0000 0.0525 0.1425)
+(0.0030 0.0525 0.1425)
+(0.0060 0.0525 0.1425)
+(-0.0060 0.0555 0.1425)
+(-0.0030 0.0555 0.1425)
+(0.0000 0.0555 0.1425)
+(0.0030 0.0555 0.1425)
+(0.0060 0.0555 0.1425)
+(-0.0060 0.0585 0.1425)
+(-0.0030 0.0585 0.1425)
+(0.0000 0.0585 0.1425)
+(0.0030 0.0585 0.1425)
+(0.0060 0.0585 0.1425)
+(-0.0060 0.0615 0.1425)
+(-0.0030 0.0615 0.1425)
+(0.0000 0.0615 0.1425)
+(0.0030 0.0615 0.1425)
+(0.0060 0.0615 0.1425)
+(-0.0060 0.0645 0.1425)
+(-0.0030 0.0645 0.1425)
+(0.0000 0.0645 0.1425)
+(0.0030 0.0645 0.1425)
+(0.0060 0.0645 0.1425)
+(-0.0060 0.0675 0.1425)
+(-0.0030 0.0675 0.1425)
+(0.0000 0.0675 0.1425)
+(0.0030 0.0675 0.1425)
+(0.0060 0.0675 0.1425)
+(-0.0060 0.0705 0.1425)
+(-0.0030 0.0705 0.1425)
+(0.0000 0.0705 0.1425)
+(0.0030 0.0705 0.1425)
+(0.0060 0.0705 0.1425)
+(-0.0060 0.0735 0.1425)
+(-0.0030 0.0735 0.1425)
+(0.0000 0.0735 0.1425)
+(0.0030 0.0735 0.1425)
+(0.0060 0.0735 0.1425)
+(-0.0060 -0.0735 0.1455)
+(-0.0030 -0.0735 0.1455)
+(0.0000 -0.0735 0.1455)
+(0.0030 -0.0735 0.1455)
+(0.0060 -0.0735 0.1455)
+(-0.0060 -0.0705 0.1455)
+(-0.0030 -0.0705 0.1455)
+(0.0000 -0.0705 0.1455)
+(0.0030 -0.0705 0.1455)
+(0.0060 -0.0705 0.1455)
+(-0.0060 -0.0675 0.1455)
+(-0.0030 -0.0675 0.1455)
+(0.0000 -0.0675 0.1455)
+(0.0030 -0.0675 0.1455)
+(0.0060 -0.0675 0.1455)
+(-0.0060 -0.0645 0.1455)
+(-0.0030 -0.0645 0.1455)
+(0.0000 -0.0645 0.1455)
+(0.0030 -0.0645 0.1455)
+(0.0060 -0.0645 0.1455)
+(-0.0060 -0.0615 0.1455)
+(-0.0030 -0.0615 0.1455)
+(0.0000 -0.0615 0.1455)
+(0.0030 -0.0615 0.1455)
+(0.0060 -0.0615 0.1455)
+(-0.0060 -0.0585 0.1455)
+(-0.0030 -0.0585 0.1455)
+(0.0000 -0.0585 0.1455)
+(0.0030 -0.0585 0.1455)
+(0.0060 -0.0585 0.1455)
+(-0.0060 -0.0555 0.1455)
+(-0.0030 -0.0555 0.1455)
+(0.0000 -0.0555 0.1455)
+(0.0030 -0.0555 0.1455)
+(0.0060 -0.0555 0.1455)
+(-0.0060 -0.0525 0.1455)
+(-0.0030 -0.0525 0.1455)
+(0.0000 -0.0525 0.1455)
+(0.0030 -0.0525 0.1455)
+(0.0060 -0.0525 0.1455)
+(-0.0060 -0.0495 0.1455)
+(-0.0030 -0.0495 0.1455)
+(0.0000 -0.0495 0.1455)
+(0.0030 -0.0495 0.1455)
+(0.0060 -0.0495 0.1455)
+(-0.0060 -0.0465 0.1455)
+(-0.0030 -0.0465 0.1455)
+(0.0000 -0.0465 0.1455)
+(0.0030 -0.0465 0.1455)
+(0.0060 -0.0465 0.1455)
+(-0.0060 -0.0435 0.1455)
+(-0.0030 -0.0435 0.1455)
+(0.0000 -0.0435 0.1455)
+(0.0030 -0.0435 0.1455)
+(0.0060 -0.0435 0.1455)
+(-0.0060 -0.0405 0.1455)
+(-0.0030 -0.0405 0.1455)
+(0.0000 -0.0405 0.1455)
+(0.0030 -0.0405 0.1455)
+(0.0060 -0.0405 0.1455)
+(-0.0060 -0.0375 0.1455)
+(-0.0030 -0.0375 0.1455)
+(0.0000 -0.0375 0.1455)
+(0.0030 -0.0375 0.1455)
+(0.0060 -0.0375 0.1455)
+(-0.0060 -0.0345 0.1455)
+(-0.0030 -0.0345 0.1455)
+(0.0000 -0.0345 0.1455)
+(0.0030 -0.0345 0.1455)
+(0.0060 -0.0345 0.1455)
+(-0.0060 -0.0315 0.1455)
+(-0.0030 -0.0315 0.1455)
+(0.0000 -0.0315 0.1455)
+(0.0030 -0.0315 0.1455)
+(0.0060 -0.0315 0.1455)
+(-0.0060 -0.0285 0.1455)
+(-0.0030 -0.0285 0.1455)
+(0.0000 -0.0285 0.1455)
+(0.0030 -0.0285 0.1455)
+(0.0060 -0.0285 0.1455)
+(-0.0060 -0.0255 0.1455)
+(-0.0030 -0.0255 0.1455)
+(0.0000 -0.0255 0.1455)
+(0.0030 -0.0255 0.1455)
+(0.0060 -0.0255 0.1455)
+(-0.0060 -0.0225 0.1455)
+(-0.0030 -0.0225 0.1455)
+(0.0000 -0.0225 0.1455)
+(0.0030 -0.0225 0.1455)
+(0.0060 -0.0225 0.1455)
+(-0.0060 -0.0195 0.1455)
+(-0.0030 -0.0195 0.1455)
+(0.0000 -0.0195 0.1455)
+(0.0030 -0.0195 0.1455)
+(0.0060 -0.0195 0.1455)
+(-0.0060 -0.0165 0.1455)
+(-0.0030 -0.0165 0.1455)
+(0.0000 -0.0165 0.1455)
+(0.0030 -0.0165 0.1455)
+(0.0060 -0.0165 0.1455)
+(-0.0060 -0.0135 0.1455)
+(-0.0030 -0.0135 0.1455)
+(0.0000 -0.0135 0.1455)
+(0.0030 -0.0135 0.1455)
+(0.0060 -0.0135 0.1455)
+(-0.0060 -0.0105 0.1455)
+(-0.0030 -0.0105 0.1455)
+(0.0000 -0.0105 0.1455)
+(0.0030 -0.0105 0.1455)
+(0.0060 -0.0105 0.1455)
+(-0.0060 -0.0075 0.1455)
+(-0.0030 -0.0075 0.1455)
+(0.0000 -0.0075 0.1455)
+(0.0030 -0.0075 0.1455)
+(0.0060 -0.0075 0.1455)
+(-0.0060 -0.0045 0.1455)
+(-0.0030 -0.0045 0.1455)
+(0.0000 -0.0045 0.1455)
+(0.0030 -0.0045 0.1455)
+(0.0060 -0.0045 0.1455)
+(-0.0060 -0.0015 0.1455)
+(-0.0030 -0.0015 0.1455)
+(0.0000 -0.0015 0.1455)
+(0.0030 -0.0015 0.1455)
+(0.0060 -0.0015 0.1455)
+(-0.0060 0.0015 0.1455)
+(-0.0030 0.0015 0.1455)
+(0.0000 0.0015 0.1455)
+(0.0030 0.0015 0.1455)
+(0.0060 0.0015 0.1455)
+(-0.0060 0.0045 0.1455)
+(-0.0030 0.0045 0.1455)
+(0.0000 0.0045 0.1455)
+(0.0030 0.0045 0.1455)
+(0.0060 0.0045 0.1455)
+(-0.0060 0.0075 0.1455)
+(-0.0030 0.0075 0.1455)
+(0.0000 0.0075 0.1455)
+(0.0030 0.0075 0.1455)
+(0.0060 0.0075 0.1455)
+(-0.0060 0.0105 0.1455)
+(-0.0030 0.0105 0.1455)
+(0.0000 0.0105 0.1455)
+(0.0030 0.0105 0.1455)
+(0.0060 0.0105 0.1455)
+(-0.0060 0.0135 0.1455)
+(-0.0030 0.0135 0.1455)
+(0.0000 0.0135 0.1455)
+(0.0030 0.0135 0.1455)
+(0.0060 0.0135 0.1455)
+(-0.0060 0.0165 0.1455)
+(-0.0030 0.0165 0.1455)
+(0.0000 0.0165 0.1455)
+(0.0030 0.0165 0.1455)
+(0.0060 0.0165 0.1455)
+(-0.0060 0.0195 0.1455)
+(-0.0030 0.0195 0.1455)
+(0.0000 0.0195 0.1455)
+(0.0030 0.0195 0.1455)
+(0.0060 0.0195 0.1455)
+(-0.0060 0.0225 0.1455)
+(-0.0030 0.0225 0.1455)
+(0.0000 0.0225 0.1455)
+(0.0030 0.0225 0.1455)
+(0.0060 0.0225 0.1455)
+(-0.0060 0.0255 0.1455)
+(-0.0030 0.0255 0.1455)
+(0.0000 0.0255 0.1455)
+(0.0030 0.0255 0.1455)
+(0.0060 0.0255 0.1455)
+(-0.0060 0.0285 0.1455)
+(-0.0030 0.0285 0.1455)
+(0.0000 0.0285 0.1455)
+(0.0030 0.0285 0.1455)
+(0.0060 0.0285 0.1455)
+(-0.0060 0.0315 0.1455)
+(-0.0030 0.0315 0.1455)
+(0.0000 0.0315 0.1455)
+(0.0030 0.0315 0.1455)
+(0.0060 0.0315 0.1455)
+(-0.0060 0.0345 0.1455)
+(-0.0030 0.0345 0.1455)
+(0.0000 0.0345 0.1455)
+(0.0030 0.0345 0.1455)
+(0.0060 0.0345 0.1455)
+(-0.0060 0.0375 0.1455)
+(-0.0030 0.0375 0.1455)
+(0.0000 0.0375 0.1455)
+(0.0030 0.0375 0.1455)
+(0.0060 0.0375 0.1455)
+(-0.0060 0.0405 0.1455)
+(-0.0030 0.0405 0.1455)
+(0.0000 0.0405 0.1455)
+(0.0030 0.0405 0.1455)
+(0.0060 0.0405 0.1455)
+(-0.0060 0.0435 0.1455)
+(-0.0030 0.0435 0.1455)
+(0.0000 0.0435 0.1455)
+(0.0030 0.0435 0.1455)
+(0.0060 0.0435 0.1455)
+(-0.0060 0.0465 0.1455)
+(-0.0030 0.0465 0.1455)
+(0.0000 0.0465 0.1455)
+(0.0030 0.0465 0.1455)
+(0.0060 0.0465 0.1455)
+(-0.0060 0.0495 0.1455)
+(-0.0030 0.0495 0.1455)
+(0.0000 0.0495 0.1455)
+(0.0030 0.0495 0.1455)
+(0.0060 0.0495 0.1455)
+(-0.0060 0.0525 0.1455)
+(-0.0030 0.0525 0.1455)
+(0.0000 0.0525 0.1455)
+(0.0030 0.0525 0.1455)
+(0.0060 0.0525 0.1455)
+(-0.0060 0.0555 0.1455)
+(-0.0030 0.0555 0.1455)
+(0.0000 0.0555 0.1455)
+(0.0030 0.0555 0.1455)
+(0.0060 0.0555 0.1455)
+(-0.0060 0.0585 0.1455)
+(-0.0030 0.0585 0.1455)
+(0.0000 0.0585 0.1455)
+(0.0030 0.0585 0.1455)
+(0.0060 0.0585 0.1455)
+(-0.0060 0.0615 0.1455)
+(-0.0030 0.0615 0.1455)
+(0.0000 0.0615 0.1455)
+(0.0030 0.0615 0.1455)
+(0.0060 0.0615 0.1455)
+(-0.0060 0.0645 0.1455)
+(-0.0030 0.0645 0.1455)
+(0.0000 0.0645 0.1455)
+(0.0030 0.0645 0.1455)
+(0.0060 0.0645 0.1455)
+(-0.0060 0.0675 0.1455)
+(-0.0030 0.0675 0.1455)
+(0.0000 0.0675 0.1455)
+(0.0030 0.0675 0.1455)
+(0.0060 0.0675 0.1455)
+(-0.0060 0.0705 0.1455)
+(-0.0030 0.0705 0.1455)
+(0.0000 0.0705 0.1455)
+(0.0030 0.0705 0.1455)
+(0.0060 0.0705 0.1455)
+(-0.0060 0.0735 0.1455)
+(-0.0030 0.0735 0.1455)
+(0.0000 0.0735 0.1455)
+(0.0030 0.0735 0.1455)
+(0.0060 0.0735 0.1455)
+(-0.0060 -0.0735 0.1485)
+(-0.0030 -0.0735 0.1485)
+(0.0000 -0.0735 0.1485)
+(0.0030 -0.0735 0.1485)
+(0.0060 -0.0735 0.1485)
+(-0.0060 -0.0705 0.1485)
+(-0.0030 -0.0705 0.1485)
+(0.0000 -0.0705 0.1485)
+(0.0030 -0.0705 0.1485)
+(0.0060 -0.0705 0.1485)
+(-0.0060 -0.0675 0.1485)
+(-0.0030 -0.0675 0.1485)
+(0.0000 -0.0675 0.1485)
+(0.0030 -0.0675 0.1485)
+(0.0060 -0.0675 0.1485)
+(-0.0060 -0.0645 0.1485)
+(-0.0030 -0.0645 0.1485)
+(0.0000 -0.0645 0.1485)
+(0.0030 -0.0645 0.1485)
+(0.0060 -0.0645 0.1485)
+(-0.0060 -0.0615 0.1485)
+(-0.0030 -0.0615 0.1485)
+(0.0000 -0.0615 0.1485)
+(0.0030 -0.0615 0.1485)
+(0.0060 -0.0615 0.1485)
+(-0.0060 -0.0585 0.1485)
+(-0.0030 -0.0585 0.1485)
+(0.0000 -0.0585 0.1485)
+(0.0030 -0.0585 0.1485)
+(0.0060 -0.0585 0.1485)
+(-0.0060 -0.0555 0.1485)
+(-0.0030 -0.0555 0.1485)
+(0.0000 -0.0555 0.1485)
+(0.0030 -0.0555 0.1485)
+(0.0060 -0.0555 0.1485)
+(-0.0060 -0.0525 0.1485)
+(-0.0030 -0.0525 0.1485)
+(0.0000 -0.0525 0.1485)
+(0.0030 -0.0525 0.1485)
+(0.0060 -0.0525 0.1485)
+(-0.0060 -0.0495 0.1485)
+(-0.0030 -0.0495 0.1485)
+(0.0000 -0.0495 0.1485)
+(0.0030 -0.0495 0.1485)
+(0.0060 -0.0495 0.1485)
+(-0.0060 -0.0465 0.1485)
+(-0.0030 -0.0465 0.1485)
+(0.0000 -0.0465 0.1485)
+(0.0030 -0.0465 0.1485)
+(0.0060 -0.0465 0.1485)
+(-0.0060 -0.0435 0.1485)
+(-0.0030 -0.0435 0.1485)
+(0.0000 -0.0435 0.1485)
+(0.0030 -0.0435 0.1485)
+(0.0060 -0.0435 0.1485)
+(-0.0060 -0.0405 0.1485)
+(-0.0030 -0.0405 0.1485)
+(0.0000 -0.0405 0.1485)
+(0.0030 -0.0405 0.1485)
+(0.0060 -0.0405 0.1485)
+(-0.0060 -0.0375 0.1485)
+(-0.0030 -0.0375 0.1485)
+(0.0000 -0.0375 0.1485)
+(0.0030 -0.0375 0.1485)
+(0.0060 -0.0375 0.1485)
+(-0.0060 -0.0345 0.1485)
+(-0.0030 -0.0345 0.1485)
+(0.0000 -0.0345 0.1485)
+(0.0030 -0.0345 0.1485)
+(0.0060 -0.0345 0.1485)
+(-0.0060 -0.0315 0.1485)
+(-0.0030 -0.0315 0.1485)
+(0.0000 -0.0315 0.1485)
+(0.0030 -0.0315 0.1485)
+(0.0060 -0.0315 0.1485)
+(-0.0060 -0.0285 0.1485)
+(-0.0030 -0.0285 0.1485)
+(0.0000 -0.0285 0.1485)
+(0.0030 -0.0285 0.1485)
+(0.0060 -0.0285 0.1485)
+(-0.0060 -0.0255 0.1485)
+(-0.0030 -0.0255 0.1485)
+(0.0000 -0.0255 0.1485)
+(0.0030 -0.0255 0.1485)
+(0.0060 -0.0255 0.1485)
+(-0.0060 -0.0225 0.1485)
+(-0.0030 -0.0225 0.1485)
+(0.0000 -0.0225 0.1485)
+(0.0030 -0.0225 0.1485)
+(0.0060 -0.0225 0.1485)
+(-0.0060 -0.0195 0.1485)
+(-0.0030 -0.0195 0.1485)
+(0.0000 -0.0195 0.1485)
+(0.0030 -0.0195 0.1485)
+(0.0060 -0.0195 0.1485)
+(-0.0060 -0.0165 0.1485)
+(-0.0030 -0.0165 0.1485)
+(0.0000 -0.0165 0.1485)
+(0.0030 -0.0165 0.1485)
+(0.0060 -0.0165 0.1485)
+(-0.0060 -0.0135 0.1485)
+(-0.0030 -0.0135 0.1485)
+(0.0000 -0.0135 0.1485)
+(0.0030 -0.0135 0.1485)
+(0.0060 -0.0135 0.1485)
+(-0.0060 -0.0105 0.1485)
+(-0.0030 -0.0105 0.1485)
+(0.0000 -0.0105 0.1485)
+(0.0030 -0.0105 0.1485)
+(0.0060 -0.0105 0.1485)
+(-0.0060 -0.0075 0.1485)
+(-0.0030 -0.0075 0.1485)
+(0.0000 -0.0075 0.1485)
+(0.0030 -0.0075 0.1485)
+(0.0060 -0.0075 0.1485)
+(-0.0060 -0.0045 0.1485)
+(-0.0030 -0.0045 0.1485)
+(0.0000 -0.0045 0.1485)
+(0.0030 -0.0045 0.1485)
+(0.0060 -0.0045 0.1485)
+(-0.0060 -0.0015 0.1485)
+(-0.0030 -0.0015 0.1485)
+(0.0000 -0.0015 0.1485)
+(0.0030 -0.0015 0.1485)
+(0.0060 -0.0015 0.1485)
+(-0.0060 0.0015 0.1485)
+(-0.0030 0.0015 0.1485)
+(0.0000 0.0015 0.1485)
+(0.0030 0.0015 0.1485)
+(0.0060 0.0015 0.1485)
+(-0.0060 0.0045 0.1485)
+(-0.0030 0.0045 0.1485)
+(0.0000 0.0045 0.1485)
+(0.0030 0.0045 0.1485)
+(0.0060 0.0045 0.1485)
+(-0.0060 0.0075 0.1485)
+(-0.0030 0.0075 0.1485)
+(0.0000 0.0075 0.1485)
+(0.0030 0.0075 0.1485)
+(0.0060 0.0075 0.1485)
+(-0.0060 0.0105 0.1485)
+(-0.0030 0.0105 0.1485)
+(0.0000 0.0105 0.1485)
+(0.0030 0.0105 0.1485)
+(0.0060 0.0105 0.1485)
+(-0.0060 0.0135 0.1485)
+(-0.0030 0.0135 0.1485)
+(0.0000 0.0135 0.1485)
+(0.0030 0.0135 0.1485)
+(0.0060 0.0135 0.1485)
+(-0.0060 0.0165 0.1485)
+(-0.0030 0.0165 0.1485)
+(0.0000 0.0165 0.1485)
+(0.0030 0.0165 0.1485)
+(0.0060 0.0165 0.1485)
+(-0.0060 0.0195 0.1485)
+(-0.0030 0.0195 0.1485)
+(0.0000 0.0195 0.1485)
+(0.0030 0.0195 0.1485)
+(0.0060 0.0195 0.1485)
+(-0.0060 0.0225 0.1485)
+(-0.0030 0.0225 0.1485)
+(0.0000 0.0225 0.1485)
+(0.0030 0.0225 0.1485)
+(0.0060 0.0225 0.1485)
+(-0.0060 0.0255 0.1485)
+(-0.0030 0.0255 0.1485)
+(0.0000 0.0255 0.1485)
+(0.0030 0.0255 0.1485)
+(0.0060 0.0255 0.1485)
+(-0.0060 0.0285 0.1485)
+(-0.0030 0.0285 0.1485)
+(0.0000 0.0285 0.1485)
+(0.0030 0.0285 0.1485)
+(0.0060 0.0285 0.1485)
+(-0.0060 0.0315 0.1485)
+(-0.0030 0.0315 0.1485)
+(0.0000 0.0315 0.1485)
+(0.0030 0.0315 0.1485)
+(0.0060 0.0315 0.1485)
+(-0.0060 0.0345 0.1485)
+(-0.0030 0.0345 0.1485)
+(0.0000 0.0345 0.1485)
+(0.0030 0.0345 0.1485)
+(0.0060 0.0345 0.1485)
+(-0.0060 0.0375 0.1485)
+(-0.0030 0.0375 0.1485)
+(0.0000 0.0375 0.1485)
+(0.0030 0.0375 0.1485)
+(0.0060 0.0375 0.1485)
+(-0.0060 0.0405 0.1485)
+(-0.0030 0.0405 0.1485)
+(0.0000 0.0405 0.1485)
+(0.0030 0.0405 0.1485)
+(0.0060 0.0405 0.1485)
+(-0.0060 0.0435 0.1485)
+(-0.0030 0.0435 0.1485)
+(0.0000 0.0435 0.1485)
+(0.0030 0.0435 0.1485)
+(0.0060 0.0435 0.1485)
+(-0.0060 0.0465 0.1485)
+(-0.0030 0.0465 0.1485)
+(0.0000 0.0465 0.1485)
+(0.0030 0.0465 0.1485)
+(0.0060 0.0465 0.1485)
+(-0.0060 0.0495 0.1485)
+(-0.0030 0.0495 0.1485)
+(0.0000 0.0495 0.1485)
+(0.0030 0.0495 0.1485)
+(0.0060 0.0495 0.1485)
+(-0.0060 0.0525 0.1485)
+(-0.0030 0.0525 0.1485)
+(0.0000 0.0525 0.1485)
+(0.0030 0.0525 0.1485)
+(0.0060 0.0525 0.1485)
+(-0.0060 0.0555 0.1485)
+(-0.0030 0.0555 0.1485)
+(0.0000 0.0555 0.1485)
+(0.0030 0.0555 0.1485)
+(0.0060 0.0555 0.1485)
+(-0.0060 0.0585 0.1485)
+(-0.0030 0.0585 0.1485)
+(0.0000 0.0585 0.1485)
+(0.0030 0.0585 0.1485)
+(0.0060 0.0585 0.1485)
+(-0.0060 0.0615 0.1485)
+(-0.0030 0.0615 0.1485)
+(0.0000 0.0615 0.1485)
+(0.0030 0.0615 0.1485)
+(0.0060 0.0615 0.1485)
+(-0.0060 0.0645 0.1485)
+(-0.0030 0.0645 0.1485)
+(0.0000 0.0645 0.1485)
+(0.0030 0.0645 0.1485)
+(0.0060 0.0645 0.1485)
+(-0.0060 0.0675 0.1485)
+(-0.0030 0.0675 0.1485)
+(0.0000 0.0675 0.1485)
+(0.0030 0.0675 0.1485)
+(0.0060 0.0675 0.1485)
+(-0.0060 0.0705 0.1485)
+(-0.0030 0.0705 0.1485)
+(0.0000 0.0705 0.1485)
+(0.0030 0.0705 0.1485)
+(0.0060 0.0705 0.1485)
+(-0.0060 0.0735 0.1485)
+(-0.0030 0.0735 0.1485)
+(0.0000 0.0735 0.1485)
+(0.0030 0.0735 0.1485)
+(0.0060 0.0735 0.1485)
+(-0.0060 -0.0735 0.1515)
+(-0.0030 -0.0735 0.1515)
+(0.0000 -0.0735 0.1515)
+(0.0030 -0.0735 0.1515)
+(0.0060 -0.0735 0.1515)
+(-0.0060 -0.0705 0.1515)
+(-0.0030 -0.0705 0.1515)
+(0.0000 -0.0705 0.1515)
+(0.0030 -0.0705 0.1515)
+(0.0060 -0.0705 0.1515)
+(-0.0060 -0.0675 0.1515)
+(-0.0030 -0.0675 0.1515)
+(0.0000 -0.0675 0.1515)
+(0.0030 -0.0675 0.1515)
+(0.0060 -0.0675 0.1515)
+(-0.0060 -0.0645 0.1515)
+(-0.0030 -0.0645 0.1515)
+(0.0000 -0.0645 0.1515)
+(0.0030 -0.0645 0.1515)
+(0.0060 -0.0645 0.1515)
+(-0.0060 -0.0615 0.1515)
+(-0.0030 -0.0615 0.1515)
+(0.0000 -0.0615 0.1515)
+(0.0030 -0.0615 0.1515)
+(0.0060 -0.0615 0.1515)
+(-0.0060 -0.0585 0.1515)
+(-0.0030 -0.0585 0.1515)
+(0.0000 -0.0585 0.1515)
+(0.0030 -0.0585 0.1515)
+(0.0060 -0.0585 0.1515)
+(-0.0060 -0.0555 0.1515)
+(-0.0030 -0.0555 0.1515)
+(0.0000 -0.0555 0.1515)
+(0.0030 -0.0555 0.1515)
+(0.0060 -0.0555 0.1515)
+(-0.0060 -0.0525 0.1515)
+(-0.0030 -0.0525 0.1515)
+(0.0000 -0.0525 0.1515)
+(0.0030 -0.0525 0.1515)
+(0.0060 -0.0525 0.1515)
+(-0.0060 -0.0495 0.1515)
+(-0.0030 -0.0495 0.1515)
+(0.0000 -0.0495 0.1515)
+(0.0030 -0.0495 0.1515)
+(0.0060 -0.0495 0.1515)
+(-0.0060 -0.0465 0.1515)
+(-0.0030 -0.0465 0.1515)
+(0.0000 -0.0465 0.1515)
+(0.0030 -0.0465 0.1515)
+(0.0060 -0.0465 0.1515)
+(-0.0060 -0.0435 0.1515)
+(-0.0030 -0.0435 0.1515)
+(0.0000 -0.0435 0.1515)
+(0.0030 -0.0435 0.1515)
+(0.0060 -0.0435 0.1515)
+(-0.0060 -0.0405 0.1515)
+(-0.0030 -0.0405 0.1515)
+(0.0000 -0.0405 0.1515)
+(0.0030 -0.0405 0.1515)
+(0.0060 -0.0405 0.1515)
+(-0.0060 -0.0375 0.1515)
+(-0.0030 -0.0375 0.1515)
+(0.0000 -0.0375 0.1515)
+(0.0030 -0.0375 0.1515)
+(0.0060 -0.0375 0.1515)
+(-0.0060 -0.0345 0.1515)
+(-0.0030 -0.0345 0.1515)
+(0.0000 -0.0345 0.1515)
+(0.0030 -0.0345 0.1515)
+(0.0060 -0.0345 0.1515)
+(-0.0060 -0.0315 0.1515)
+(-0.0030 -0.0315 0.1515)
+(0.0000 -0.0315 0.1515)
+(0.0030 -0.0315 0.1515)
+(0.0060 -0.0315 0.1515)
+(-0.0060 -0.0285 0.1515)
+(-0.0030 -0.0285 0.1515)
+(0.0000 -0.0285 0.1515)
+(0.0030 -0.0285 0.1515)
+(0.0060 -0.0285 0.1515)
+(-0.0060 -0.0255 0.1515)
+(-0.0030 -0.0255 0.1515)
+(0.0000 -0.0255 0.1515)
+(0.0030 -0.0255 0.1515)
+(0.0060 -0.0255 0.1515)
+(-0.0060 -0.0225 0.1515)
+(-0.0030 -0.0225 0.1515)
+(0.0000 -0.0225 0.1515)
+(0.0030 -0.0225 0.1515)
+(0.0060 -0.0225 0.1515)
+(-0.0060 -0.0195 0.1515)
+(-0.0030 -0.0195 0.1515)
+(0.0000 -0.0195 0.1515)
+(0.0030 -0.0195 0.1515)
+(0.0060 -0.0195 0.1515)
+(-0.0060 -0.0165 0.1515)
+(-0.0030 -0.0165 0.1515)
+(0.0000 -0.0165 0.1515)
+(0.0030 -0.0165 0.1515)
+(0.0060 -0.0165 0.1515)
+(-0.0060 -0.0135 0.1515)
+(-0.0030 -0.0135 0.1515)
+(0.0000 -0.0135 0.1515)
+(0.0030 -0.0135 0.1515)
+(0.0060 -0.0135 0.1515)
+(-0.0060 -0.0105 0.1515)
+(-0.0030 -0.0105 0.1515)
+(0.0000 -0.0105 0.1515)
+(0.0030 -0.0105 0.1515)
+(0.0060 -0.0105 0.1515)
+(-0.0060 -0.0075 0.1515)
+(-0.0030 -0.0075 0.1515)
+(0.0000 -0.0075 0.1515)
+(0.0030 -0.0075 0.1515)
+(0.0060 -0.0075 0.1515)
+(-0.0060 -0.0045 0.1515)
+(-0.0030 -0.0045 0.1515)
+(0.0000 -0.0045 0.1515)
+(0.0030 -0.0045 0.1515)
+(0.0060 -0.0045 0.1515)
+(-0.0060 -0.0015 0.1515)
+(-0.0030 -0.0015 0.1515)
+(0.0000 -0.0015 0.1515)
+(0.0030 -0.0015 0.1515)
+(0.0060 -0.0015 0.1515)
+(-0.0060 0.0015 0.1515)
+(-0.0030 0.0015 0.1515)
+(0.0000 0.0015 0.1515)
+(0.0030 0.0015 0.1515)
+(0.0060 0.0015 0.1515)
+(-0.0060 0.0045 0.1515)
+(-0.0030 0.0045 0.1515)
+(0.0000 0.0045 0.1515)
+(0.0030 0.0045 0.1515)
+(0.0060 0.0045 0.1515)
+(-0.0060 0.0075 0.1515)
+(-0.0030 0.0075 0.1515)
+(0.0000 0.0075 0.1515)
+(0.0030 0.0075 0.1515)
+(0.0060 0.0075 0.1515)
+(-0.0060 0.0105 0.1515)
+(-0.0030 0.0105 0.1515)
+(0.0000 0.0105 0.1515)
+(0.0030 0.0105 0.1515)
+(0.0060 0.0105 0.1515)
+(-0.0060 0.0135 0.1515)
+(-0.0030 0.0135 0.1515)
+(0.0000 0.0135 0.1515)
+(0.0030 0.0135 0.1515)
+(0.0060 0.0135 0.1515)
+(-0.0060 0.0165 0.1515)
+(-0.0030 0.0165 0.1515)
+(0.0000 0.0165 0.1515)
+(0.0030 0.0165 0.1515)
+(0.0060 0.0165 0.1515)
+(-0.0060 0.0195 0.1515)
+(-0.0030 0.0195 0.1515)
+(0.0000 0.0195 0.1515)
+(0.0030 0.0195 0.1515)
+(0.0060 0.0195 0.1515)
+(-0.0060 0.0225 0.1515)
+(-0.0030 0.0225 0.1515)
+(0.0000 0.0225 0.1515)
+(0.0030 0.0225 0.1515)
+(0.0060 0.0225 0.1515)
+(-0.0060 0.0255 0.1515)
+(-0.0030 0.0255 0.1515)
+(0.0000 0.0255 0.1515)
+(0.0030 0.0255 0.1515)
+(0.0060 0.0255 0.1515)
+(-0.0060 0.0285 0.1515)
+(-0.0030 0.0285 0.1515)
+(0.0000 0.0285 0.1515)
+(0.0030 0.0285 0.1515)
+(0.0060 0.0285 0.1515)
+(-0.0060 0.0315 0.1515)
+(-0.0030 0.0315 0.1515)
+(0.0000 0.0315 0.1515)
+(0.0030 0.0315 0.1515)
+(0.0060 0.0315 0.1515)
+(-0.0060 0.0345 0.1515)
+(-0.0030 0.0345 0.1515)
+(0.0000 0.0345 0.1515)
+(0.0030 0.0345 0.1515)
+(0.0060 0.0345 0.1515)
+(-0.0060 0.0375 0.1515)
+(-0.0030 0.0375 0.1515)
+(0.0000 0.0375 0.1515)
+(0.0030 0.0375 0.1515)
+(0.0060 0.0375 0.1515)
+(-0.0060 0.0405 0.1515)
+(-0.0030 0.0405 0.1515)
+(0.0000 0.0405 0.1515)
+(0.0030 0.0405 0.1515)
+(0.0060 0.0405 0.1515)
+(-0.0060 0.0435 0.1515)
+(-0.0030 0.0435 0.1515)
+(0.0000 0.0435 0.1515)
+(0.0030 0.0435 0.1515)
+(0.0060 0.0435 0.1515)
+(-0.0060 0.0465 0.1515)
+(-0.0030 0.0465 0.1515)
+(0.0000 0.0465 0.1515)
+(0.0030 0.0465 0.1515)
+(0.0060 0.0465 0.1515)
+(-0.0060 0.0495 0.1515)
+(-0.0030 0.0495 0.1515)
+(0.0000 0.0495 0.1515)
+(0.0030 0.0495 0.1515)
+(0.0060 0.0495 0.1515)
+(-0.0060 0.0525 0.1515)
+(-0.0030 0.0525 0.1515)
+(0.0000 0.0525 0.1515)
+(0.0030 0.0525 0.1515)
+(0.0060 0.0525 0.1515)
+(-0.0060 0.0555 0.1515)
+(-0.0030 0.0555 0.1515)
+(0.0000 0.0555 0.1515)
+(0.0030 0.0555 0.1515)
+(0.0060 0.0555 0.1515)
+(-0.0060 0.0585 0.1515)
+(-0.0030 0.0585 0.1515)
+(0.0000 0.0585 0.1515)
+(0.0030 0.0585 0.1515)
+(0.0060 0.0585 0.1515)
+(-0.0060 0.0615 0.1515)
+(-0.0030 0.0615 0.1515)
+(0.0000 0.0615 0.1515)
+(0.0030 0.0615 0.1515)
+(0.0060 0.0615 0.1515)
+(-0.0060 0.0645 0.1515)
+(-0.0030 0.0645 0.1515)
+(0.0000 0.0645 0.1515)
+(0.0030 0.0645 0.1515)
+(0.0060 0.0645 0.1515)
+(-0.0060 0.0675 0.1515)
+(-0.0030 0.0675 0.1515)
+(0.0000 0.0675 0.1515)
+(0.0030 0.0675 0.1515)
+(0.0060 0.0675 0.1515)
+(-0.0060 0.0705 0.1515)
+(-0.0030 0.0705 0.1515)
+(0.0000 0.0705 0.1515)
+(0.0030 0.0705 0.1515)
+(0.0060 0.0705 0.1515)
+(-0.0060 0.0735 0.1515)
+(-0.0030 0.0735 0.1515)
+(0.0000 0.0735 0.1515)
+(0.0030 0.0735 0.1515)
+(0.0060 0.0735 0.1515)
+(-0.0060 -0.0735 0.1545)
+(-0.0030 -0.0735 0.1545)
+(0.0000 -0.0735 0.1545)
+(0.0030 -0.0735 0.1545)
+(0.0060 -0.0735 0.1545)
+(-0.0060 -0.0705 0.1545)
+(-0.0030 -0.0705 0.1545)
+(0.0000 -0.0705 0.1545)
+(0.0030 -0.0705 0.1545)
+(0.0060 -0.0705 0.1545)
+(-0.0060 -0.0675 0.1545)
+(-0.0030 -0.0675 0.1545)
+(0.0000 -0.0675 0.1545)
+(0.0030 -0.0675 0.1545)
+(0.0060 -0.0675 0.1545)
+(-0.0060 -0.0645 0.1545)
+(-0.0030 -0.0645 0.1545)
+(0.0000 -0.0645 0.1545)
+(0.0030 -0.0645 0.1545)
+(0.0060 -0.0645 0.1545)
+(-0.0060 -0.0615 0.1545)
+(-0.0030 -0.0615 0.1545)
+(0.0000 -0.0615 0.1545)
+(0.0030 -0.0615 0.1545)
+(0.0060 -0.0615 0.1545)
+(-0.0060 -0.0585 0.1545)
+(-0.0030 -0.0585 0.1545)
+(0.0000 -0.0585 0.1545)
+(0.0030 -0.0585 0.1545)
+(0.0060 -0.0585 0.1545)
+(-0.0060 -0.0555 0.1545)
+(-0.0030 -0.0555 0.1545)
+(0.0000 -0.0555 0.1545)
+(0.0030 -0.0555 0.1545)
+(0.0060 -0.0555 0.1545)
+(-0.0060 -0.0525 0.1545)
+(-0.0030 -0.0525 0.1545)
+(0.0000 -0.0525 0.1545)
+(0.0030 -0.0525 0.1545)
+(0.0060 -0.0525 0.1545)
+(-0.0060 -0.0495 0.1545)
+(-0.0030 -0.0495 0.1545)
+(0.0000 -0.0495 0.1545)
+(0.0030 -0.0495 0.1545)
+(0.0060 -0.0495 0.1545)
+(-0.0060 -0.0465 0.1545)
+(-0.0030 -0.0465 0.1545)
+(0.0000 -0.0465 0.1545)
+(0.0030 -0.0465 0.1545)
+(0.0060 -0.0465 0.1545)
+(-0.0060 -0.0435 0.1545)
+(-0.0030 -0.0435 0.1545)
+(0.0000 -0.0435 0.1545)
+(0.0030 -0.0435 0.1545)
+(0.0060 -0.0435 0.1545)
+(-0.0060 -0.0405 0.1545)
+(-0.0030 -0.0405 0.1545)
+(0.0000 -0.0405 0.1545)
+(0.0030 -0.0405 0.1545)
+(0.0060 -0.0405 0.1545)
+(-0.0060 -0.0375 0.1545)
+(-0.0030 -0.0375 0.1545)
+(0.0000 -0.0375 0.1545)
+(0.0030 -0.0375 0.1545)
+(0.0060 -0.0375 0.1545)
+(-0.0060 -0.0345 0.1545)
+(-0.0030 -0.0345 0.1545)
+(0.0000 -0.0345 0.1545)
+(0.0030 -0.0345 0.1545)
+(0.0060 -0.0345 0.1545)
+(-0.0060 -0.0315 0.1545)
+(-0.0030 -0.0315 0.1545)
+(0.0000 -0.0315 0.1545)
+(0.0030 -0.0315 0.1545)
+(0.0060 -0.0315 0.1545)
+(-0.0060 -0.0285 0.1545)
+(-0.0030 -0.0285 0.1545)
+(0.0000 -0.0285 0.1545)
+(0.0030 -0.0285 0.1545)
+(0.0060 -0.0285 0.1545)
+(-0.0060 -0.0255 0.1545)
+(-0.0030 -0.0255 0.1545)
+(0.0000 -0.0255 0.1545)
+(0.0030 -0.0255 0.1545)
+(0.0060 -0.0255 0.1545)
+(-0.0060 -0.0225 0.1545)
+(-0.0030 -0.0225 0.1545)
+(0.0000 -0.0225 0.1545)
+(0.0030 -0.0225 0.1545)
+(0.0060 -0.0225 0.1545)
+(-0.0060 -0.0195 0.1545)
+(-0.0030 -0.0195 0.1545)
+(0.0000 -0.0195 0.1545)
+(0.0030 -0.0195 0.1545)
+(0.0060 -0.0195 0.1545)
+(-0.0060 -0.0165 0.1545)
+(-0.0030 -0.0165 0.1545)
+(0.0000 -0.0165 0.1545)
+(0.0030 -0.0165 0.1545)
+(0.0060 -0.0165 0.1545)
+(-0.0060 -0.0135 0.1545)
+(-0.0030 -0.0135 0.1545)
+(0.0000 -0.0135 0.1545)
+(0.0030 -0.0135 0.1545)
+(0.0060 -0.0135 0.1545)
+(-0.0060 -0.0105 0.1545)
+(-0.0030 -0.0105 0.1545)
+(0.0000 -0.0105 0.1545)
+(0.0030 -0.0105 0.1545)
+(0.0060 -0.0105 0.1545)
+(-0.0060 -0.0075 0.1545)
+(-0.0030 -0.0075 0.1545)
+(0.0000 -0.0075 0.1545)
+(0.0030 -0.0075 0.1545)
+(0.0060 -0.0075 0.1545)
+(-0.0060 -0.0045 0.1545)
+(-0.0030 -0.0045 0.1545)
+(0.0000 -0.0045 0.1545)
+(0.0030 -0.0045 0.1545)
+(0.0060 -0.0045 0.1545)
+(-0.0060 -0.0015 0.1545)
+(-0.0030 -0.0015 0.1545)
+(0.0000 -0.0015 0.1545)
+(0.0030 -0.0015 0.1545)
+(0.0060 -0.0015 0.1545)
+(-0.0060 0.0015 0.1545)
+(-0.0030 0.0015 0.1545)
+(0.0000 0.0015 0.1545)
+(0.0030 0.0015 0.1545)
+(0.0060 0.0015 0.1545)
+(-0.0060 0.0045 0.1545)
+(-0.0030 0.0045 0.1545)
+(0.0000 0.0045 0.1545)
+(0.0030 0.0045 0.1545)
+(0.0060 0.0045 0.1545)
+(-0.0060 0.0075 0.1545)
+(-0.0030 0.0075 0.1545)
+(0.0000 0.0075 0.1545)
+(0.0030 0.0075 0.1545)
+(0.0060 0.0075 0.1545)
+(-0.0060 0.0105 0.1545)
+(-0.0030 0.0105 0.1545)
+(0.0000 0.0105 0.1545)
+(0.0030 0.0105 0.1545)
+(0.0060 0.0105 0.1545)
+(-0.0060 0.0135 0.1545)
+(-0.0030 0.0135 0.1545)
+(0.0000 0.0135 0.1545)
+(0.0030 0.0135 0.1545)
+(0.0060 0.0135 0.1545)
+(-0.0060 0.0165 0.1545)
+(-0.0030 0.0165 0.1545)
+(0.0000 0.0165 0.1545)
+(0.0030 0.0165 0.1545)
+(0.0060 0.0165 0.1545)
+(-0.0060 0.0195 0.1545)
+(-0.0030 0.0195 0.1545)
+(0.0000 0.0195 0.1545)
+(0.0030 0.0195 0.1545)
+(0.0060 0.0195 0.1545)
+(-0.0060 0.0225 0.1545)
+(-0.0030 0.0225 0.1545)
+(0.0000 0.0225 0.1545)
+(0.0030 0.0225 0.1545)
+(0.0060 0.0225 0.1545)
+(-0.0060 0.0255 0.1545)
+(-0.0030 0.0255 0.1545)
+(0.0000 0.0255 0.1545)
+(0.0030 0.0255 0.1545)
+(0.0060 0.0255 0.1545)
+(-0.0060 0.0285 0.1545)
+(-0.0030 0.0285 0.1545)
+(0.0000 0.0285 0.1545)
+(0.0030 0.0285 0.1545)
+(0.0060 0.0285 0.1545)
+(-0.0060 0.0315 0.1545)
+(-0.0030 0.0315 0.1545)
+(0.0000 0.0315 0.1545)
+(0.0030 0.0315 0.1545)
+(0.0060 0.0315 0.1545)
+(-0.0060 0.0345 0.1545)
+(-0.0030 0.0345 0.1545)
+(0.0000 0.0345 0.1545)
+(0.0030 0.0345 0.1545)
+(0.0060 0.0345 0.1545)
+(-0.0060 0.0375 0.1545)
+(-0.0030 0.0375 0.1545)
+(0.0000 0.0375 0.1545)
+(0.0030 0.0375 0.1545)
+(0.0060 0.0375 0.1545)
+(-0.0060 0.0405 0.1545)
+(-0.0030 0.0405 0.1545)
+(0.0000 0.0405 0.1545)
+(0.0030 0.0405 0.1545)
+(0.0060 0.0405 0.1545)
+(-0.0060 0.0435 0.1545)
+(-0.0030 0.0435 0.1545)
+(0.0000 0.0435 0.1545)
+(0.0030 0.0435 0.1545)
+(0.0060 0.0435 0.1545)
+(-0.0060 0.0465 0.1545)
+(-0.0030 0.0465 0.1545)
+(0.0000 0.0465 0.1545)
+(0.0030 0.0465 0.1545)
+(0.0060 0.0465 0.1545)
+(-0.0060 0.0495 0.1545)
+(-0.0030 0.0495 0.1545)
+(0.0000 0.0495 0.1545)
+(0.0030 0.0495 0.1545)
+(0.0060 0.0495 0.1545)
+(-0.0060 0.0525 0.1545)
+(-0.0030 0.0525 0.1545)
+(0.0000 0.0525 0.1545)
+(0.0030 0.0525 0.1545)
+(0.0060 0.0525 0.1545)
+(-0.0060 0.0555 0.1545)
+(-0.0030 0.0555 0.1545)
+(0.0000 0.0555 0.1545)
+(0.0030 0.0555 0.1545)
+(0.0060 0.0555 0.1545)
+(-0.0060 0.0585 0.1545)
+(-0.0030 0.0585 0.1545)
+(0.0000 0.0585 0.1545)
+(0.0030 0.0585 0.1545)
+(0.0060 0.0585 0.1545)
+(-0.0060 0.0615 0.1545)
+(-0.0030 0.0615 0.1545)
+(0.0000 0.0615 0.1545)
+(0.0030 0.0615 0.1545)
+(0.0060 0.0615 0.1545)
+(-0.0060 0.0645 0.1545)
+(-0.0030 0.0645 0.1545)
+(0.0000 0.0645 0.1545)
+(0.0030 0.0645 0.1545)
+(0.0060 0.0645 0.1545)
+(-0.0060 0.0675 0.1545)
+(-0.0030 0.0675 0.1545)
+(0.0000 0.0675 0.1545)
+(0.0030 0.0675 0.1545)
+(0.0060 0.0675 0.1545)
+(-0.0060 0.0705 0.1545)
+(-0.0030 0.0705 0.1545)
+(0.0000 0.0705 0.1545)
+(0.0030 0.0705 0.1545)
+(0.0060 0.0705 0.1545)
+(-0.0060 0.0735 0.1545)
+(-0.0030 0.0735 0.1545)
+(0.0000 0.0735 0.1545)
+(0.0030 0.0735 0.1545)
+(0.0060 0.0735 0.1545)
+(-0.0060 -0.0735 0.1575)
+(-0.0030 -0.0735 0.1575)
+(0.0000 -0.0735 0.1575)
+(0.0030 -0.0735 0.1575)
+(0.0060 -0.0735 0.1575)
+(-0.0060 -0.0705 0.1575)
+(-0.0030 -0.0705 0.1575)
+(0.0000 -0.0705 0.1575)
+(0.0030 -0.0705 0.1575)
+(0.0060 -0.0705 0.1575)
+(-0.0060 -0.0675 0.1575)
+(-0.0030 -0.0675 0.1575)
+(0.0000 -0.0675 0.1575)
+(0.0030 -0.0675 0.1575)
+(0.0060 -0.0675 0.1575)
+(-0.0060 -0.0645 0.1575)
+(-0.0030 -0.0645 0.1575)
+(0.0000 -0.0645 0.1575)
+(0.0030 -0.0645 0.1575)
+(0.0060 -0.0645 0.1575)
+(-0.0060 -0.0615 0.1575)
+(-0.0030 -0.0615 0.1575)
+(0.0000 -0.0615 0.1575)
+(0.0030 -0.0615 0.1575)
+(0.0060 -0.0615 0.1575)
+(-0.0060 -0.0585 0.1575)
+(-0.0030 -0.0585 0.1575)
+(0.0000 -0.0585 0.1575)
+(0.0030 -0.0585 0.1575)
+(0.0060 -0.0585 0.1575)
+(-0.0060 -0.0555 0.1575)
+(-0.0030 -0.0555 0.1575)
+(0.0000 -0.0555 0.1575)
+(0.0030 -0.0555 0.1575)
+(0.0060 -0.0555 0.1575)
+(-0.0060 -0.0525 0.1575)
+(-0.0030 -0.0525 0.1575)
+(0.0000 -0.0525 0.1575)
+(0.0030 -0.0525 0.1575)
+(0.0060 -0.0525 0.1575)
+(-0.0060 -0.0495 0.1575)
+(-0.0030 -0.0495 0.1575)
+(0.0000 -0.0495 0.1575)
+(0.0030 -0.0495 0.1575)
+(0.0060 -0.0495 0.1575)
+(-0.0060 -0.0465 0.1575)
+(-0.0030 -0.0465 0.1575)
+(0.0000 -0.0465 0.1575)
+(0.0030 -0.0465 0.1575)
+(0.0060 -0.0465 0.1575)
+(-0.0060 -0.0435 0.1575)
+(-0.0030 -0.0435 0.1575)
+(0.0000 -0.0435 0.1575)
+(0.0030 -0.0435 0.1575)
+(0.0060 -0.0435 0.1575)
+(-0.0060 -0.0405 0.1575)
+(-0.0030 -0.0405 0.1575)
+(0.0000 -0.0405 0.1575)
+(0.0030 -0.0405 0.1575)
+(0.0060 -0.0405 0.1575)
+(-0.0060 -0.0375 0.1575)
+(-0.0030 -0.0375 0.1575)
+(0.0000 -0.0375 0.1575)
+(0.0030 -0.0375 0.1575)
+(0.0060 -0.0375 0.1575)
+(-0.0060 -0.0345 0.1575)
+(-0.0030 -0.0345 0.1575)
+(0.0000 -0.0345 0.1575)
+(0.0030 -0.0345 0.1575)
+(0.0060 -0.0345 0.1575)
+(-0.0060 -0.0315 0.1575)
+(-0.0030 -0.0315 0.1575)
+(0.0000 -0.0315 0.1575)
+(0.0030 -0.0315 0.1575)
+(0.0060 -0.0315 0.1575)
+(-0.0060 -0.0285 0.1575)
+(-0.0030 -0.0285 0.1575)
+(0.0000 -0.0285 0.1575)
+(0.0030 -0.0285 0.1575)
+(0.0060 -0.0285 0.1575)
+(-0.0060 -0.0255 0.1575)
+(-0.0030 -0.0255 0.1575)
+(0.0000 -0.0255 0.1575)
+(0.0030 -0.0255 0.1575)
+(0.0060 -0.0255 0.1575)
+(-0.0060 -0.0225 0.1575)
+(-0.0030 -0.0225 0.1575)
+(0.0000 -0.0225 0.1575)
+(0.0030 -0.0225 0.1575)
+(0.0060 -0.0225 0.1575)
+(-0.0060 -0.0195 0.1575)
+(-0.0030 -0.0195 0.1575)
+(0.0000 -0.0195 0.1575)
+(0.0030 -0.0195 0.1575)
+(0.0060 -0.0195 0.1575)
+(-0.0060 -0.0165 0.1575)
+(-0.0030 -0.0165 0.1575)
+(0.0000 -0.0165 0.1575)
+(0.0030 -0.0165 0.1575)
+(0.0060 -0.0165 0.1575)
+(-0.0060 -0.0135 0.1575)
+(-0.0030 -0.0135 0.1575)
+(0.0000 -0.0135 0.1575)
+(0.0030 -0.0135 0.1575)
+(0.0060 -0.0135 0.1575)
+(-0.0060 -0.0105 0.1575)
+(-0.0030 -0.0105 0.1575)
+(0.0000 -0.0105 0.1575)
+(0.0030 -0.0105 0.1575)
+(0.0060 -0.0105 0.1575)
+(-0.0060 -0.0075 0.1575)
+(-0.0030 -0.0075 0.1575)
+(0.0000 -0.0075 0.1575)
+(0.0030 -0.0075 0.1575)
+(0.0060 -0.0075 0.1575)
+(-0.0060 -0.0045 0.1575)
+(-0.0030 -0.0045 0.1575)
+(0.0000 -0.0045 0.1575)
+(0.0030 -0.0045 0.1575)
+(0.0060 -0.0045 0.1575)
+(-0.0060 -0.0015 0.1575)
+(-0.0030 -0.0015 0.1575)
+(0.0000 -0.0015 0.1575)
+(0.0030 -0.0015 0.1575)
+(0.0060 -0.0015 0.1575)
+(-0.0060 0.0015 0.1575)
+(-0.0030 0.0015 0.1575)
+(0.0000 0.0015 0.1575)
+(0.0030 0.0015 0.1575)
+(0.0060 0.0015 0.1575)
+(-0.0060 0.0045 0.1575)
+(-0.0030 0.0045 0.1575)
+(0.0000 0.0045 0.1575)
+(0.0030 0.0045 0.1575)
+(0.0060 0.0045 0.1575)
+(-0.0060 0.0075 0.1575)
+(-0.0030 0.0075 0.1575)
+(0.0000 0.0075 0.1575)
+(0.0030 0.0075 0.1575)
+(0.0060 0.0075 0.1575)
+(-0.0060 0.0105 0.1575)
+(-0.0030 0.0105 0.1575)
+(0.0000 0.0105 0.1575)
+(0.0030 0.0105 0.1575)
+(0.0060 0.0105 0.1575)
+(-0.0060 0.0135 0.1575)
+(-0.0030 0.0135 0.1575)
+(0.0000 0.0135 0.1575)
+(0.0030 0.0135 0.1575)
+(0.0060 0.0135 0.1575)
+(-0.0060 0.0165 0.1575)
+(-0.0030 0.0165 0.1575)
+(0.0000 0.0165 0.1575)
+(0.0030 0.0165 0.1575)
+(0.0060 0.0165 0.1575)
+(-0.0060 0.0195 0.1575)
+(-0.0030 0.0195 0.1575)
+(0.0000 0.0195 0.1575)
+(0.0030 0.0195 0.1575)
+(0.0060 0.0195 0.1575)
+(-0.0060 0.0225 0.1575)
+(-0.0030 0.0225 0.1575)
+(0.0000 0.0225 0.1575)
+(0.0030 0.0225 0.1575)
+(0.0060 0.0225 0.1575)
+(-0.0060 0.0255 0.1575)
+(-0.0030 0.0255 0.1575)
+(0.0000 0.0255 0.1575)
+(0.0030 0.0255 0.1575)
+(0.0060 0.0255 0.1575)
+(-0.0060 0.0285 0.1575)
+(-0.0030 0.0285 0.1575)
+(0.0000 0.0285 0.1575)
+(0.0030 0.0285 0.1575)
+(0.0060 0.0285 0.1575)
+(-0.0060 0.0315 0.1575)
+(-0.0030 0.0315 0.1575)
+(0.0000 0.0315 0.1575)
+(0.0030 0.0315 0.1575)
+(0.0060 0.0315 0.1575)
+(-0.0060 0.0345 0.1575)
+(-0.0030 0.0345 0.1575)
+(0.0000 0.0345 0.1575)
+(0.0030 0.0345 0.1575)
+(0.0060 0.0345 0.1575)
+(-0.0060 0.0375 0.1575)
+(-0.0030 0.0375 0.1575)
+(0.0000 0.0375 0.1575)
+(0.0030 0.0375 0.1575)
+(0.0060 0.0375 0.1575)
+(-0.0060 0.0405 0.1575)
+(-0.0030 0.0405 0.1575)
+(0.0000 0.0405 0.1575)
+(0.0030 0.0405 0.1575)
+(0.0060 0.0405 0.1575)
+(-0.0060 0.0435 0.1575)
+(-0.0030 0.0435 0.1575)
+(0.0000 0.0435 0.1575)
+(0.0030 0.0435 0.1575)
+(0.0060 0.0435 0.1575)
+(-0.0060 0.0465 0.1575)
+(-0.0030 0.0465 0.1575)
+(0.0000 0.0465 0.1575)
+(0.0030 0.0465 0.1575)
+(0.0060 0.0465 0.1575)
+(-0.0060 0.0495 0.1575)
+(-0.0030 0.0495 0.1575)
+(0.0000 0.0495 0.1575)
+(0.0030 0.0495 0.1575)
+(0.0060 0.0495 0.1575)
+(-0.0060 0.0525 0.1575)
+(-0.0030 0.0525 0.1575)
+(0.0000 0.0525 0.1575)
+(0.0030 0.0525 0.1575)
+(0.0060 0.0525 0.1575)
+(-0.0060 0.0555 0.1575)
+(-0.0030 0.0555 0.1575)
+(0.0000 0.0555 0.1575)
+(0.0030 0.0555 0.1575)
+(0.0060 0.0555 0.1575)
+(-0.0060 0.0585 0.1575)
+(-0.0030 0.0585 0.1575)
+(0.0000 0.0585 0.1575)
+(0.0030 0.0585 0.1575)
+(0.0060 0.0585 0.1575)
+(-0.0060 0.0615 0.1575)
+(-0.0030 0.0615 0.1575)
+(0.0000 0.0615 0.1575)
+(0.0030 0.0615 0.1575)
+(0.0060 0.0615 0.1575)
+(-0.0060 0.0645 0.1575)
+(-0.0030 0.0645 0.1575)
+(0.0000 0.0645 0.1575)
+(0.0030 0.0645 0.1575)
+(0.0060 0.0645 0.1575)
+(-0.0060 0.0675 0.1575)
+(-0.0030 0.0675 0.1575)
+(0.0000 0.0675 0.1575)
+(0.0030 0.0675 0.1575)
+(0.0060 0.0675 0.1575)
+(-0.0060 0.0705 0.1575)
+(-0.0030 0.0705 0.1575)
+(0.0000 0.0705 0.1575)
+(0.0030 0.0705 0.1575)
+(0.0060 0.0705 0.1575)
+(-0.0060 0.0735 0.1575)
+(-0.0030 0.0735 0.1575)
+(0.0000 0.0735 0.1575)
+(0.0030 0.0735 0.1575)
+(0.0060 0.0735 0.1575)
+(-0.0060 -0.0735 0.1605)
+(-0.0030 -0.0735 0.1605)
+(0.0000 -0.0735 0.1605)
+(0.0030 -0.0735 0.1605)
+(0.0060 -0.0735 0.1605)
+(-0.0060 -0.0705 0.1605)
+(-0.0030 -0.0705 0.1605)
+(0.0000 -0.0705 0.1605)
+(0.0030 -0.0705 0.1605)
+(0.0060 -0.0705 0.1605)
+(-0.0060 -0.0675 0.1605)
+(-0.0030 -0.0675 0.1605)
+(0.0000 -0.0675 0.1605)
+(0.0030 -0.0675 0.1605)
+(0.0060 -0.0675 0.1605)
+(-0.0060 -0.0645 0.1605)
+(-0.0030 -0.0645 0.1605)
+(0.0000 -0.0645 0.1605)
+(0.0030 -0.0645 0.1605)
+(0.0060 -0.0645 0.1605)
+(-0.0060 -0.0615 0.1605)
+(-0.0030 -0.0615 0.1605)
+(0.0000 -0.0615 0.1605)
+(0.0030 -0.0615 0.1605)
+(0.0060 -0.0615 0.1605)
+(-0.0060 -0.0585 0.1605)
+(-0.0030 -0.0585 0.1605)
+(0.0000 -0.0585 0.1605)
+(0.0030 -0.0585 0.1605)
+(0.0060 -0.0585 0.1605)
+(-0.0060 -0.0555 0.1605)
+(-0.0030 -0.0555 0.1605)
+(0.0000 -0.0555 0.1605)
+(0.0030 -0.0555 0.1605)
+(0.0060 -0.0555 0.1605)
+(-0.0060 -0.0525 0.1605)
+(-0.0030 -0.0525 0.1605)
+(0.0000 -0.0525 0.1605)
+(0.0030 -0.0525 0.1605)
+(0.0060 -0.0525 0.1605)
+(-0.0060 -0.0495 0.1605)
+(-0.0030 -0.0495 0.1605)
+(0.0000 -0.0495 0.1605)
+(0.0030 -0.0495 0.1605)
+(0.0060 -0.0495 0.1605)
+(-0.0060 -0.0465 0.1605)
+(-0.0030 -0.0465 0.1605)
+(0.0000 -0.0465 0.1605)
+(0.0030 -0.0465 0.1605)
+(0.0060 -0.0465 0.1605)
+(-0.0060 -0.0435 0.1605)
+(-0.0030 -0.0435 0.1605)
+(0.0000 -0.0435 0.1605)
+(0.0030 -0.0435 0.1605)
+(0.0060 -0.0435 0.1605)
+(-0.0060 -0.0405 0.1605)
+(-0.0030 -0.0405 0.1605)
+(0.0000 -0.0405 0.1605)
+(0.0030 -0.0405 0.1605)
+(0.0060 -0.0405 0.1605)
+(-0.0060 -0.0375 0.1605)
+(-0.0030 -0.0375 0.1605)
+(0.0000 -0.0375 0.1605)
+(0.0030 -0.0375 0.1605)
+(0.0060 -0.0375 0.1605)
+(-0.0060 -0.0345 0.1605)
+(-0.0030 -0.0345 0.1605)
+(0.0000 -0.0345 0.1605)
+(0.0030 -0.0345 0.1605)
+(0.0060 -0.0345 0.1605)
+(-0.0060 -0.0315 0.1605)
+(-0.0030 -0.0315 0.1605)
+(0.0000 -0.0315 0.1605)
+(0.0030 -0.0315 0.1605)
+(0.0060 -0.0315 0.1605)
+(-0.0060 -0.0285 0.1605)
+(-0.0030 -0.0285 0.1605)
+(0.0000 -0.0285 0.1605)
+(0.0030 -0.0285 0.1605)
+(0.0060 -0.0285 0.1605)
+(-0.0060 -0.0255 0.1605)
+(-0.0030 -0.0255 0.1605)
+(0.0000 -0.0255 0.1605)
+(0.0030 -0.0255 0.1605)
+(0.0060 -0.0255 0.1605)
+(-0.0060 -0.0225 0.1605)
+(-0.0030 -0.0225 0.1605)
+(0.0000 -0.0225 0.1605)
+(0.0030 -0.0225 0.1605)
+(0.0060 -0.0225 0.1605)
+(-0.0060 -0.0195 0.1605)
+(-0.0030 -0.0195 0.1605)
+(0.0000 -0.0195 0.1605)
+(0.0030 -0.0195 0.1605)
+(0.0060 -0.0195 0.1605)
+(-0.0060 -0.0165 0.1605)
+(-0.0030 -0.0165 0.1605)
+(0.0000 -0.0165 0.1605)
+(0.0030 -0.0165 0.1605)
+(0.0060 -0.0165 0.1605)
+(-0.0060 -0.0135 0.1605)
+(-0.0030 -0.0135 0.1605)
+(0.0000 -0.0135 0.1605)
+(0.0030 -0.0135 0.1605)
+(0.0060 -0.0135 0.1605)
+(-0.0060 -0.0105 0.1605)
+(-0.0030 -0.0105 0.1605)
+(0.0000 -0.0105 0.1605)
+(0.0030 -0.0105 0.1605)
+(0.0060 -0.0105 0.1605)
+(-0.0060 -0.0075 0.1605)
+(-0.0030 -0.0075 0.1605)
+(0.0000 -0.0075 0.1605)
+(0.0030 -0.0075 0.1605)
+(0.0060 -0.0075 0.1605)
+(-0.0060 -0.0045 0.1605)
+(-0.0030 -0.0045 0.1605)
+(0.0000 -0.0045 0.1605)
+(0.0030 -0.0045 0.1605)
+(0.0060 -0.0045 0.1605)
+(-0.0060 -0.0015 0.1605)
+(-0.0030 -0.0015 0.1605)
+(0.0000 -0.0015 0.1605)
+(0.0030 -0.0015 0.1605)
+(0.0060 -0.0015 0.1605)
+(-0.0060 0.0015 0.1605)
+(-0.0030 0.0015 0.1605)
+(0.0000 0.0015 0.1605)
+(0.0030 0.0015 0.1605)
+(0.0060 0.0015 0.1605)
+(-0.0060 0.0045 0.1605)
+(-0.0030 0.0045 0.1605)
+(0.0000 0.0045 0.1605)
+(0.0030 0.0045 0.1605)
+(0.0060 0.0045 0.1605)
+(-0.0060 0.0075 0.1605)
+(-0.0030 0.0075 0.1605)
+(0.0000 0.0075 0.1605)
+(0.0030 0.0075 0.1605)
+(0.0060 0.0075 0.1605)
+(-0.0060 0.0105 0.1605)
+(-0.0030 0.0105 0.1605)
+(0.0000 0.0105 0.1605)
+(0.0030 0.0105 0.1605)
+(0.0060 0.0105 0.1605)
+(-0.0060 0.0135 0.1605)
+(-0.0030 0.0135 0.1605)
+(0.0000 0.0135 0.1605)
+(0.0030 0.0135 0.1605)
+(0.0060 0.0135 0.1605)
+(-0.0060 0.0165 0.1605)
+(-0.0030 0.0165 0.1605)
+(0.0000 0.0165 0.1605)
+(0.0030 0.0165 0.1605)
+(0.0060 0.0165 0.1605)
+(-0.0060 0.0195 0.1605)
+(-0.0030 0.0195 0.1605)
+(0.0000 0.0195 0.1605)
+(0.0030 0.0195 0.1605)
+(0.0060 0.0195 0.1605)
+(-0.0060 0.0225 0.1605)
+(-0.0030 0.0225 0.1605)
+(0.0000 0.0225 0.1605)
+(0.0030 0.0225 0.1605)
+(0.0060 0.0225 0.1605)
+(-0.0060 0.0255 0.1605)
+(-0.0030 0.0255 0.1605)
+(0.0000 0.0255 0.1605)
+(0.0030 0.0255 0.1605)
+(0.0060 0.0255 0.1605)
+(-0.0060 0.0285 0.1605)
+(-0.0030 0.0285 0.1605)
+(0.0000 0.0285 0.1605)
+(0.0030 0.0285 0.1605)
+(0.0060 0.0285 0.1605)
+(-0.0060 0.0315 0.1605)
+(-0.0030 0.0315 0.1605)
+(0.0000 0.0315 0.1605)
+(0.0030 0.0315 0.1605)
+(0.0060 0.0315 0.1605)
+(-0.0060 0.0345 0.1605)
+(-0.0030 0.0345 0.1605)
+(0.0000 0.0345 0.1605)
+(0.0030 0.0345 0.1605)
+(0.0060 0.0345 0.1605)
+(-0.0060 0.0375 0.1605)
+(-0.0030 0.0375 0.1605)
+(0.0000 0.0375 0.1605)
+(0.0030 0.0375 0.1605)
+(0.0060 0.0375 0.1605)
+(-0.0060 0.0405 0.1605)
+(-0.0030 0.0405 0.1605)
+(0.0000 0.0405 0.1605)
+(0.0030 0.0405 0.1605)
+(0.0060 0.0405 0.1605)
+(-0.0060 0.0435 0.1605)
+(-0.0030 0.0435 0.1605)
+(0.0000 0.0435 0.1605)
+(0.0030 0.0435 0.1605)
+(0.0060 0.0435 0.1605)
+(-0.0060 0.0465 0.1605)
+(-0.0030 0.0465 0.1605)
+(0.0000 0.0465 0.1605)
+(0.0030 0.0465 0.1605)
+(0.0060 0.0465 0.1605)
+(-0.0060 0.0495 0.1605)
+(-0.0030 0.0495 0.1605)
+(0.0000 0.0495 0.1605)
+(0.0030 0.0495 0.1605)
+(0.0060 0.0495 0.1605)
+(-0.0060 0.0525 0.1605)
+(-0.0030 0.0525 0.1605)
+(0.0000 0.0525 0.1605)
+(0.0030 0.0525 0.1605)
+(0.0060 0.0525 0.1605)
+(-0.0060 0.0555 0.1605)
+(-0.0030 0.0555 0.1605)
+(0.0000 0.0555 0.1605)
+(0.0030 0.0555 0.1605)
+(0.0060 0.0555 0.1605)
+(-0.0060 0.0585 0.1605)
+(-0.0030 0.0585 0.1605)
+(0.0000 0.0585 0.1605)
+(0.0030 0.0585 0.1605)
+(0.0060 0.0585 0.1605)
+(-0.0060 0.0615 0.1605)
+(-0.0030 0.0615 0.1605)
+(0.0000 0.0615 0.1605)
+(0.0030 0.0615 0.1605)
+(0.0060 0.0615 0.1605)
+(-0.0060 0.0645 0.1605)
+(-0.0030 0.0645 0.1605)
+(0.0000 0.0645 0.1605)
+(0.0030 0.0645 0.1605)
+(0.0060 0.0645 0.1605)
+(-0.0060 0.0675 0.1605)
+(-0.0030 0.0675 0.1605)
+(0.0000 0.0675 0.1605)
+(0.0030 0.0675 0.1605)
+(0.0060 0.0675 0.1605)
+(-0.0060 0.0705 0.1605)
+(-0.0030 0.0705 0.1605)
+(0.0000 0.0705 0.1605)
+(0.0030 0.0705 0.1605)
+(0.0060 0.0705 0.1605)
+(-0.0060 0.0735 0.1605)
+(-0.0030 0.0735 0.1605)
+(0.0000 0.0735 0.1605)
+(0.0030 0.0735 0.1605)
+(0.0060 0.0735 0.1605)
+(-0.0060 -0.0735 0.1635)
+(-0.0030 -0.0735 0.1635)
+(0.0000 -0.0735 0.1635)
+(0.0030 -0.0735 0.1635)
+(0.0060 -0.0735 0.1635)
+(-0.0060 -0.0705 0.1635)
+(-0.0030 -0.0705 0.1635)
+(0.0000 -0.0705 0.1635)
+(0.0030 -0.0705 0.1635)
+(0.0060 -0.0705 0.1635)
+(-0.0060 -0.0675 0.1635)
+(-0.0030 -0.0675 0.1635)
+(0.0000 -0.0675 0.1635)
+(0.0030 -0.0675 0.1635)
+(0.0060 -0.0675 0.1635)
+(-0.0060 -0.0645 0.1635)
+(-0.0030 -0.0645 0.1635)
+(0.0000 -0.0645 0.1635)
+(0.0030 -0.0645 0.1635)
+(0.0060 -0.0645 0.1635)
+(-0.0060 -0.0615 0.1635)
+(-0.0030 -0.0615 0.1635)
+(0.0000 -0.0615 0.1635)
+(0.0030 -0.0615 0.1635)
+(0.0060 -0.0615 0.1635)
+(-0.0060 -0.0585 0.1635)
+(-0.0030 -0.0585 0.1635)
+(0.0000 -0.0585 0.1635)
+(0.0030 -0.0585 0.1635)
+(0.0060 -0.0585 0.1635)
+(-0.0060 -0.0555 0.1635)
+(-0.0030 -0.0555 0.1635)
+(0.0000 -0.0555 0.1635)
+(0.0030 -0.0555 0.1635)
+(0.0060 -0.0555 0.1635)
+(-0.0060 -0.0525 0.1635)
+(-0.0030 -0.0525 0.1635)
+(0.0000 -0.0525 0.1635)
+(0.0030 -0.0525 0.1635)
+(0.0060 -0.0525 0.1635)
+(-0.0060 -0.0495 0.1635)
+(-0.0030 -0.0495 0.1635)
+(0.0000 -0.0495 0.1635)
+(0.0030 -0.0495 0.1635)
+(0.0060 -0.0495 0.1635)
+(-0.0060 -0.0465 0.1635)
+(-0.0030 -0.0465 0.1635)
+(0.0000 -0.0465 0.1635)
+(0.0030 -0.0465 0.1635)
+(0.0060 -0.0465 0.1635)
+(-0.0060 -0.0435 0.1635)
+(-0.0030 -0.0435 0.1635)
+(0.0000 -0.0435 0.1635)
+(0.0030 -0.0435 0.1635)
+(0.0060 -0.0435 0.1635)
+(-0.0060 -0.0405 0.1635)
+(-0.0030 -0.0405 0.1635)
+(0.0000 -0.0405 0.1635)
+(0.0030 -0.0405 0.1635)
+(0.0060 -0.0405 0.1635)
+(-0.0060 -0.0375 0.1635)
+(-0.0030 -0.0375 0.1635)
+(0.0000 -0.0375 0.1635)
+(0.0030 -0.0375 0.1635)
+(0.0060 -0.0375 0.1635)
+(-0.0060 -0.0345 0.1635)
+(-0.0030 -0.0345 0.1635)
+(0.0000 -0.0345 0.1635)
+(0.0030 -0.0345 0.1635)
+(0.0060 -0.0345 0.1635)
+(-0.0060 -0.0315 0.1635)
+(-0.0030 -0.0315 0.1635)
+(0.0000 -0.0315 0.1635)
+(0.0030 -0.0315 0.1635)
+(0.0060 -0.0315 0.1635)
+(-0.0060 -0.0285 0.1635)
+(-0.0030 -0.0285 0.1635)
+(0.0000 -0.0285 0.1635)
+(0.0030 -0.0285 0.1635)
+(0.0060 -0.0285 0.1635)
+(-0.0060 -0.0255 0.1635)
+(-0.0030 -0.0255 0.1635)
+(0.0000 -0.0255 0.1635)
+(0.0030 -0.0255 0.1635)
+(0.0060 -0.0255 0.1635)
+(-0.0060 -0.0225 0.1635)
+(-0.0030 -0.0225 0.1635)
+(0.0000 -0.0225 0.1635)
+(0.0030 -0.0225 0.1635)
+(0.0060 -0.0225 0.1635)
+(-0.0060 -0.0195 0.1635)
+(-0.0030 -0.0195 0.1635)
+(0.0000 -0.0195 0.1635)
+(0.0030 -0.0195 0.1635)
+(0.0060 -0.0195 0.1635)
+(-0.0060 -0.0165 0.1635)
+(-0.0030 -0.0165 0.1635)
+(0.0000 -0.0165 0.1635)
+(0.0030 -0.0165 0.1635)
+(0.0060 -0.0165 0.1635)
+(-0.0060 -0.0135 0.1635)
+(-0.0030 -0.0135 0.1635)
+(0.0000 -0.0135 0.1635)
+(0.0030 -0.0135 0.1635)
+(0.0060 -0.0135 0.1635)
+(-0.0060 -0.0105 0.1635)
+(-0.0030 -0.0105 0.1635)
+(0.0000 -0.0105 0.1635)
+(0.0030 -0.0105 0.1635)
+(0.0060 -0.0105 0.1635)
+(-0.0060 -0.0075 0.1635)
+(-0.0030 -0.0075 0.1635)
+(0.0000 -0.0075 0.1635)
+(0.0030 -0.0075 0.1635)
+(0.0060 -0.0075 0.1635)
+(-0.0060 -0.0045 0.1635)
+(-0.0030 -0.0045 0.1635)
+(0.0000 -0.0045 0.1635)
+(0.0030 -0.0045 0.1635)
+(0.0060 -0.0045 0.1635)
+(-0.0060 -0.0015 0.1635)
+(-0.0030 -0.0015 0.1635)
+(0.0000 -0.0015 0.1635)
+(0.0030 -0.0015 0.1635)
+(0.0060 -0.0015 0.1635)
+(-0.0060 0.0015 0.1635)
+(-0.0030 0.0015 0.1635)
+(0.0000 0.0015 0.1635)
+(0.0030 0.0015 0.1635)
+(0.0060 0.0015 0.1635)
+(-0.0060 0.0045 0.1635)
+(-0.0030 0.0045 0.1635)
+(0.0000 0.0045 0.1635)
+(0.0030 0.0045 0.1635)
+(0.0060 0.0045 0.1635)
+(-0.0060 0.0075 0.1635)
+(-0.0030 0.0075 0.1635)
+(0.0000 0.0075 0.1635)
+(0.0030 0.0075 0.1635)
+(0.0060 0.0075 0.1635)
+(-0.0060 0.0105 0.1635)
+(-0.0030 0.0105 0.1635)
+(0.0000 0.0105 0.1635)
+(0.0030 0.0105 0.1635)
+(0.0060 0.0105 0.1635)
+(-0.0060 0.0135 0.1635)
+(-0.0030 0.0135 0.1635)
+(0.0000 0.0135 0.1635)
+(0.0030 0.0135 0.1635)
+(0.0060 0.0135 0.1635)
+(-0.0060 0.0165 0.1635)
+(-0.0030 0.0165 0.1635)
+(0.0000 0.0165 0.1635)
+(0.0030 0.0165 0.1635)
+(0.0060 0.0165 0.1635)
+(-0.0060 0.0195 0.1635)
+(-0.0030 0.0195 0.1635)
+(0.0000 0.0195 0.1635)
+(0.0030 0.0195 0.1635)
+(0.0060 0.0195 0.1635)
+(-0.0060 0.0225 0.1635)
+(-0.0030 0.0225 0.1635)
+(0.0000 0.0225 0.1635)
+(0.0030 0.0225 0.1635)
+(0.0060 0.0225 0.1635)
+(-0.0060 0.0255 0.1635)
+(-0.0030 0.0255 0.1635)
+(0.0000 0.0255 0.1635)
+(0.0030 0.0255 0.1635)
+(0.0060 0.0255 0.1635)
+(-0.0060 0.0285 0.1635)
+(-0.0030 0.0285 0.1635)
+(0.0000 0.0285 0.1635)
+(0.0030 0.0285 0.1635)
+(0.0060 0.0285 0.1635)
+(-0.0060 0.0315 0.1635)
+(-0.0030 0.0315 0.1635)
+(0.0000 0.0315 0.1635)
+(0.0030 0.0315 0.1635)
+(0.0060 0.0315 0.1635)
+(-0.0060 0.0345 0.1635)
+(-0.0030 0.0345 0.1635)
+(0.0000 0.0345 0.1635)
+(0.0030 0.0345 0.1635)
+(0.0060 0.0345 0.1635)
+(-0.0060 0.0375 0.1635)
+(-0.0030 0.0375 0.1635)
+(0.0000 0.0375 0.1635)
+(0.0030 0.0375 0.1635)
+(0.0060 0.0375 0.1635)
+(-0.0060 0.0405 0.1635)
+(-0.0030 0.0405 0.1635)
+(0.0000 0.0405 0.1635)
+(0.0030 0.0405 0.1635)
+(0.0060 0.0405 0.1635)
+(-0.0060 0.0435 0.1635)
+(-0.0030 0.0435 0.1635)
+(0.0000 0.0435 0.1635)
+(0.0030 0.0435 0.1635)
+(0.0060 0.0435 0.1635)
+(-0.0060 0.0465 0.1635)
+(-0.0030 0.0465 0.1635)
+(0.0000 0.0465 0.1635)
+(0.0030 0.0465 0.1635)
+(0.0060 0.0465 0.1635)
+(-0.0060 0.0495 0.1635)
+(-0.0030 0.0495 0.1635)
+(0.0000 0.0495 0.1635)
+(0.0030 0.0495 0.1635)
+(0.0060 0.0495 0.1635)
+(-0.0060 0.0525 0.1635)
+(-0.0030 0.0525 0.1635)
+(0.0000 0.0525 0.1635)
+(0.0030 0.0525 0.1635)
+(0.0060 0.0525 0.1635)
+(-0.0060 0.0555 0.1635)
+(-0.0030 0.0555 0.1635)
+(0.0000 0.0555 0.1635)
+(0.0030 0.0555 0.1635)
+(0.0060 0.0555 0.1635)
+(-0.0060 0.0585 0.1635)
+(-0.0030 0.0585 0.1635)
+(0.0000 0.0585 0.1635)
+(0.0030 0.0585 0.1635)
+(0.0060 0.0585 0.1635)
+(-0.0060 0.0615 0.1635)
+(-0.0030 0.0615 0.1635)
+(0.0000 0.0615 0.1635)
+(0.0030 0.0615 0.1635)
+(0.0060 0.0615 0.1635)
+(-0.0060 0.0645 0.1635)
+(-0.0030 0.0645 0.1635)
+(0.0000 0.0645 0.1635)
+(0.0030 0.0645 0.1635)
+(0.0060 0.0645 0.1635)
+(-0.0060 0.0675 0.1635)
+(-0.0030 0.0675 0.1635)
+(0.0000 0.0675 0.1635)
+(0.0030 0.0675 0.1635)
+(0.0060 0.0675 0.1635)
+(-0.0060 0.0705 0.1635)
+(-0.0030 0.0705 0.1635)
+(0.0000 0.0705 0.1635)
+(0.0030 0.0705 0.1635)
+(0.0060 0.0705 0.1635)
+(-0.0060 0.0735 0.1635)
+(-0.0030 0.0735 0.1635)
+(0.0000 0.0735 0.1635)
+(0.0030 0.0735 0.1635)
+(0.0060 0.0735 0.1635)
+(-0.0060 -0.0735 0.1665)
+(-0.0030 -0.0735 0.1665)
+(0.0000 -0.0735 0.1665)
+(0.0030 -0.0735 0.1665)
+(0.0060 -0.0735 0.1665)
+(-0.0060 -0.0705 0.1665)
+(-0.0030 -0.0705 0.1665)
+(0.0000 -0.0705 0.1665)
+(0.0030 -0.0705 0.1665)
+(0.0060 -0.0705 0.1665)
+(-0.0060 -0.0675 0.1665)
+(-0.0030 -0.0675 0.1665)
+(0.0000 -0.0675 0.1665)
+(0.0030 -0.0675 0.1665)
+(0.0060 -0.0675 0.1665)
+(-0.0060 -0.0645 0.1665)
+(-0.0030 -0.0645 0.1665)
+(0.0000 -0.0645 0.1665)
+(0.0030 -0.0645 0.1665)
+(0.0060 -0.0645 0.1665)
+(-0.0060 -0.0615 0.1665)
+(-0.0030 -0.0615 0.1665)
+(0.0000 -0.0615 0.1665)
+(0.0030 -0.0615 0.1665)
+(0.0060 -0.0615 0.1665)
+(-0.0060 -0.0585 0.1665)
+(-0.0030 -0.0585 0.1665)
+(0.0000 -0.0585 0.1665)
+(0.0030 -0.0585 0.1665)
+(0.0060 -0.0585 0.1665)
+(-0.0060 -0.0555 0.1665)
+(-0.0030 -0.0555 0.1665)
+(0.0000 -0.0555 0.1665)
+(0.0030 -0.0555 0.1665)
+(0.0060 -0.0555 0.1665)
+(-0.0060 -0.0525 0.1665)
+(-0.0030 -0.0525 0.1665)
+(0.0000 -0.0525 0.1665)
+(0.0030 -0.0525 0.1665)
+(0.0060 -0.0525 0.1665)
+(-0.0060 -0.0495 0.1665)
+(-0.0030 -0.0495 0.1665)
+(0.0000 -0.0495 0.1665)
+(0.0030 -0.0495 0.1665)
+(0.0060 -0.0495 0.1665)
+(-0.0060 -0.0465 0.1665)
+(-0.0030 -0.0465 0.1665)
+(0.0000 -0.0465 0.1665)
+(0.0030 -0.0465 0.1665)
+(0.0060 -0.0465 0.1665)
+(-0.0060 -0.0435 0.1665)
+(-0.0030 -0.0435 0.1665)
+(0.0000 -0.0435 0.1665)
+(0.0030 -0.0435 0.1665)
+(0.0060 -0.0435 0.1665)
+(-0.0060 -0.0405 0.1665)
+(-0.0030 -0.0405 0.1665)
+(0.0000 -0.0405 0.1665)
+(0.0030 -0.0405 0.1665)
+(0.0060 -0.0405 0.1665)
+(-0.0060 -0.0375 0.1665)
+(-0.0030 -0.0375 0.1665)
+(0.0000 -0.0375 0.1665)
+(0.0030 -0.0375 0.1665)
+(0.0060 -0.0375 0.1665)
+(-0.0060 -0.0345 0.1665)
+(-0.0030 -0.0345 0.1665)
+(0.0000 -0.0345 0.1665)
+(0.0030 -0.0345 0.1665)
+(0.0060 -0.0345 0.1665)
+(-0.0060 -0.0315 0.1665)
+(-0.0030 -0.0315 0.1665)
+(0.0000 -0.0315 0.1665)
+(0.0030 -0.0315 0.1665)
+(0.0060 -0.0315 0.1665)
+(-0.0060 -0.0285 0.1665)
+(-0.0030 -0.0285 0.1665)
+(0.0000 -0.0285 0.1665)
+(0.0030 -0.0285 0.1665)
+(0.0060 -0.0285 0.1665)
+(-0.0060 -0.0255 0.1665)
+(-0.0030 -0.0255 0.1665)
+(0.0000 -0.0255 0.1665)
+(0.0030 -0.0255 0.1665)
+(0.0060 -0.0255 0.1665)
+(-0.0060 -0.0225 0.1665)
+(-0.0030 -0.0225 0.1665)
+(0.0000 -0.0225 0.1665)
+(0.0030 -0.0225 0.1665)
+(0.0060 -0.0225 0.1665)
+(-0.0060 -0.0195 0.1665)
+(-0.0030 -0.0195 0.1665)
+(0.0000 -0.0195 0.1665)
+(0.0030 -0.0195 0.1665)
+(0.0060 -0.0195 0.1665)
+(-0.0060 -0.0165 0.1665)
+(-0.0030 -0.0165 0.1665)
+(0.0000 -0.0165 0.1665)
+(0.0030 -0.0165 0.1665)
+(0.0060 -0.0165 0.1665)
+(-0.0060 -0.0135 0.1665)
+(-0.0030 -0.0135 0.1665)
+(0.0000 -0.0135 0.1665)
+(0.0030 -0.0135 0.1665)
+(0.0060 -0.0135 0.1665)
+(-0.0060 -0.0105 0.1665)
+(-0.0030 -0.0105 0.1665)
+(0.0000 -0.0105 0.1665)
+(0.0030 -0.0105 0.1665)
+(0.0060 -0.0105 0.1665)
+(-0.0060 -0.0075 0.1665)
+(-0.0030 -0.0075 0.1665)
+(0.0000 -0.0075 0.1665)
+(0.0030 -0.0075 0.1665)
+(0.0060 -0.0075 0.1665)
+(-0.0060 -0.0045 0.1665)
+(-0.0030 -0.0045 0.1665)
+(0.0000 -0.0045 0.1665)
+(0.0030 -0.0045 0.1665)
+(0.0060 -0.0045 0.1665)
+(-0.0060 -0.0015 0.1665)
+(-0.0030 -0.0015 0.1665)
+(0.0000 -0.0015 0.1665)
+(0.0030 -0.0015 0.1665)
+(0.0060 -0.0015 0.1665)
+(-0.0060 0.0015 0.1665)
+(-0.0030 0.0015 0.1665)
+(0.0000 0.0015 0.1665)
+(0.0030 0.0015 0.1665)
+(0.0060 0.0015 0.1665)
+(-0.0060 0.0045 0.1665)
+(-0.0030 0.0045 0.1665)
+(0.0000 0.0045 0.1665)
+(0.0030 0.0045 0.1665)
+(0.0060 0.0045 0.1665)
+(-0.0060 0.0075 0.1665)
+(-0.0030 0.0075 0.1665)
+(0.0000 0.0075 0.1665)
+(0.0030 0.0075 0.1665)
+(0.0060 0.0075 0.1665)
+(-0.0060 0.0105 0.1665)
+(-0.0030 0.0105 0.1665)
+(0.0000 0.0105 0.1665)
+(0.0030 0.0105 0.1665)
+(0.0060 0.0105 0.1665)
+(-0.0060 0.0135 0.1665)
+(-0.0030 0.0135 0.1665)
+(0.0000 0.0135 0.1665)
+(0.0030 0.0135 0.1665)
+(0.0060 0.0135 0.1665)
+(-0.0060 0.0165 0.1665)
+(-0.0030 0.0165 0.1665)
+(0.0000 0.0165 0.1665)
+(0.0030 0.0165 0.1665)
+(0.0060 0.0165 0.1665)
+(-0.0060 0.0195 0.1665)
+(-0.0030 0.0195 0.1665)
+(0.0000 0.0195 0.1665)
+(0.0030 0.0195 0.1665)
+(0.0060 0.0195 0.1665)
+(-0.0060 0.0225 0.1665)
+(-0.0030 0.0225 0.1665)
+(0.0000 0.0225 0.1665)
+(0.0030 0.0225 0.1665)
+(0.0060 0.0225 0.1665)
+(-0.0060 0.0255 0.1665)
+(-0.0030 0.0255 0.1665)
+(0.0000 0.0255 0.1665)
+(0.0030 0.0255 0.1665)
+(0.0060 0.0255 0.1665)
+(-0.0060 0.0285 0.1665)
+(-0.0030 0.0285 0.1665)
+(0.0000 0.0285 0.1665)
+(0.0030 0.0285 0.1665)
+(0.0060 0.0285 0.1665)
+(-0.0060 0.0315 0.1665)
+(-0.0030 0.0315 0.1665)
+(0.0000 0.0315 0.1665)
+(0.0030 0.0315 0.1665)
+(0.0060 0.0315 0.1665)
+(-0.0060 0.0345 0.1665)
+(-0.0030 0.0345 0.1665)
+(0.0000 0.0345 0.1665)
+(0.0030 0.0345 0.1665)
+(0.0060 0.0345 0.1665)
+(-0.0060 0.0375 0.1665)
+(-0.0030 0.0375 0.1665)
+(0.0000 0.0375 0.1665)
+(0.0030 0.0375 0.1665)
+(0.0060 0.0375 0.1665)
+(-0.0060 0.0405 0.1665)
+(-0.0030 0.0405 0.1665)
+(0.0000 0.0405 0.1665)
+(0.0030 0.0405 0.1665)
+(0.0060 0.0405 0.1665)
+(-0.0060 0.0435 0.1665)
+(-0.0030 0.0435 0.1665)
+(0.0000 0.0435 0.1665)
+(0.0030 0.0435 0.1665)
+(0.0060 0.0435 0.1665)
+(-0.0060 0.0465 0.1665)
+(-0.0030 0.0465 0.1665)
+(0.0000 0.0465 0.1665)
+(0.0030 0.0465 0.1665)
+(0.0060 0.0465 0.1665)
+(-0.0060 0.0495 0.1665)
+(-0.0030 0.0495 0.1665)
+(0.0000 0.0495 0.1665)
+(0.0030 0.0495 0.1665)
+(0.0060 0.0495 0.1665)
+(-0.0060 0.0525 0.1665)
+(-0.0030 0.0525 0.1665)
+(0.0000 0.0525 0.1665)
+(0.0030 0.0525 0.1665)
+(0.0060 0.0525 0.1665)
+(-0.0060 0.0555 0.1665)
+(-0.0030 0.0555 0.1665)
+(0.0000 0.0555 0.1665)
+(0.0030 0.0555 0.1665)
+(0.0060 0.0555 0.1665)
+(-0.0060 0.0585 0.1665)
+(-0.0030 0.0585 0.1665)
+(0.0000 0.0585 0.1665)
+(0.0030 0.0585 0.1665)
+(0.0060 0.0585 0.1665)
+(-0.0060 0.0615 0.1665)
+(-0.0030 0.0615 0.1665)
+(0.0000 0.0615 0.1665)
+(0.0030 0.0615 0.1665)
+(0.0060 0.0615 0.1665)
+(-0.0060 0.0645 0.1665)
+(-0.0030 0.0645 0.1665)
+(0.0000 0.0645 0.1665)
+(0.0030 0.0645 0.1665)
+(0.0060 0.0645 0.1665)
+(-0.0060 0.0675 0.1665)
+(-0.0030 0.0675 0.1665)
+(0.0000 0.0675 0.1665)
+(0.0030 0.0675 0.1665)
+(0.0060 0.0675 0.1665)
+(-0.0060 0.0705 0.1665)
+(-0.0030 0.0705 0.1665)
+(0.0000 0.0705 0.1665)
+(0.0030 0.0705 0.1665)
+(0.0060 0.0705 0.1665)
+(-0.0060 0.0735 0.1665)
+(-0.0030 0.0735 0.1665)
+(0.0000 0.0735 0.1665)
+(0.0030 0.0735 0.1665)
+(0.0060 0.0735 0.1665)
+(-0.0060 -0.0735 0.1695)
+(-0.0030 -0.0735 0.1695)
+(0.0000 -0.0735 0.1695)
+(0.0030 -0.0735 0.1695)
+(0.0060 -0.0735 0.1695)
+(-0.0060 -0.0705 0.1695)
+(-0.0030 -0.0705 0.1695)
+(0.0000 -0.0705 0.1695)
+(0.0030 -0.0705 0.1695)
+(0.0060 -0.0705 0.1695)
+(-0.0060 -0.0675 0.1695)
+(-0.0030 -0.0675 0.1695)
+(0.0000 -0.0675 0.1695)
+(0.0030 -0.0675 0.1695)
+(0.0060 -0.0675 0.1695)
+(-0.0060 -0.0645 0.1695)
+(-0.0030 -0.0645 0.1695)
+(0.0000 -0.0645 0.1695)
+(0.0030 -0.0645 0.1695)
+(0.0060 -0.0645 0.1695)
+(-0.0060 -0.0615 0.1695)
+(-0.0030 -0.0615 0.1695)
+(0.0000 -0.0615 0.1695)
+(0.0030 -0.0615 0.1695)
+(0.0060 -0.0615 0.1695)
+(-0.0060 -0.0585 0.1695)
+(-0.0030 -0.0585 0.1695)
+(0.0000 -0.0585 0.1695)
+(0.0030 -0.0585 0.1695)
+(0.0060 -0.0585 0.1695)
+(-0.0060 -0.0555 0.1695)
+(-0.0030 -0.0555 0.1695)
+(0.0000 -0.0555 0.1695)
+(0.0030 -0.0555 0.1695)
+(0.0060 -0.0555 0.1695)
+(-0.0060 -0.0525 0.1695)
+(-0.0030 -0.0525 0.1695)
+(0.0000 -0.0525 0.1695)
+(0.0030 -0.0525 0.1695)
+(0.0060 -0.0525 0.1695)
+(-0.0060 -0.0495 0.1695)
+(-0.0030 -0.0495 0.1695)
+(0.0000 -0.0495 0.1695)
+(0.0030 -0.0495 0.1695)
+(0.0060 -0.0495 0.1695)
+(-0.0060 -0.0465 0.1695)
+(-0.0030 -0.0465 0.1695)
+(0.0000 -0.0465 0.1695)
+(0.0030 -0.0465 0.1695)
+(0.0060 -0.0465 0.1695)
+(-0.0060 -0.0435 0.1695)
+(-0.0030 -0.0435 0.1695)
+(0.0000 -0.0435 0.1695)
+(0.0030 -0.0435 0.1695)
+(0.0060 -0.0435 0.1695)
+(-0.0060 -0.0405 0.1695)
+(-0.0030 -0.0405 0.1695)
+(0.0000 -0.0405 0.1695)
+(0.0030 -0.0405 0.1695)
+(0.0060 -0.0405 0.1695)
+(-0.0060 -0.0375 0.1695)
+(-0.0030 -0.0375 0.1695)
+(0.0000 -0.0375 0.1695)
+(0.0030 -0.0375 0.1695)
+(0.0060 -0.0375 0.1695)
+(-0.0060 -0.0345 0.1695)
+(-0.0030 -0.0345 0.1695)
+(0.0000 -0.0345 0.1695)
+(0.0030 -0.0345 0.1695)
+(0.0060 -0.0345 0.1695)
+(-0.0060 -0.0315 0.1695)
+(-0.0030 -0.0315 0.1695)
+(0.0000 -0.0315 0.1695)
+(0.0030 -0.0315 0.1695)
+(0.0060 -0.0315 0.1695)
+(-0.0060 -0.0285 0.1695)
+(-0.0030 -0.0285 0.1695)
+(0.0000 -0.0285 0.1695)
+(0.0030 -0.0285 0.1695)
+(0.0060 -0.0285 0.1695)
+(-0.0060 -0.0255 0.1695)
+(-0.0030 -0.0255 0.1695)
+(0.0000 -0.0255 0.1695)
+(0.0030 -0.0255 0.1695)
+(0.0060 -0.0255 0.1695)
+(-0.0060 -0.0225 0.1695)
+(-0.0030 -0.0225 0.1695)
+(0.0000 -0.0225 0.1695)
+(0.0030 -0.0225 0.1695)
+(0.0060 -0.0225 0.1695)
+(-0.0060 -0.0195 0.1695)
+(-0.0030 -0.0195 0.1695)
+(0.0000 -0.0195 0.1695)
+(0.0030 -0.0195 0.1695)
+(0.0060 -0.0195 0.1695)
+(-0.0060 -0.0165 0.1695)
+(-0.0030 -0.0165 0.1695)
+(0.0000 -0.0165 0.1695)
+(0.0030 -0.0165 0.1695)
+(0.0060 -0.0165 0.1695)
+(-0.0060 -0.0135 0.1695)
+(-0.0030 -0.0135 0.1695)
+(0.0000 -0.0135 0.1695)
+(0.0030 -0.0135 0.1695)
+(0.0060 -0.0135 0.1695)
+(-0.0060 -0.0105 0.1695)
+(-0.0030 -0.0105 0.1695)
+(0.0000 -0.0105 0.1695)
+(0.0030 -0.0105 0.1695)
+(0.0060 -0.0105 0.1695)
+(-0.0060 -0.0075 0.1695)
+(-0.0030 -0.0075 0.1695)
+(0.0000 -0.0075 0.1695)
+(0.0030 -0.0075 0.1695)
+(0.0060 -0.0075 0.1695)
+(-0.0060 -0.0045 0.1695)
+(-0.0030 -0.0045 0.1695)
+(0.0000 -0.0045 0.1695)
+(0.0030 -0.0045 0.1695)
+(0.0060 -0.0045 0.1695)
+(-0.0060 -0.0015 0.1695)
+(-0.0030 -0.0015 0.1695)
+(0.0000 -0.0015 0.1695)
+(0.0030 -0.0015 0.1695)
+(0.0060 -0.0015 0.1695)
+(-0.0060 0.0015 0.1695)
+(-0.0030 0.0015 0.1695)
+(0.0000 0.0015 0.1695)
+(0.0030 0.0015 0.1695)
+(0.0060 0.0015 0.1695)
+(-0.0060 0.0045 0.1695)
+(-0.0030 0.0045 0.1695)
+(0.0000 0.0045 0.1695)
+(0.0030 0.0045 0.1695)
+(0.0060 0.0045 0.1695)
+(-0.0060 0.0075 0.1695)
+(-0.0030 0.0075 0.1695)
+(0.0000 0.0075 0.1695)
+(0.0030 0.0075 0.1695)
+(0.0060 0.0075 0.1695)
+(-0.0060 0.0105 0.1695)
+(-0.0030 0.0105 0.1695)
+(0.0000 0.0105 0.1695)
+(0.0030 0.0105 0.1695)
+(0.0060 0.0105 0.1695)
+(-0.0060 0.0135 0.1695)
+(-0.0030 0.0135 0.1695)
+(0.0000 0.0135 0.1695)
+(0.0030 0.0135 0.1695)
+(0.0060 0.0135 0.1695)
+(-0.0060 0.0165 0.1695)
+(-0.0030 0.0165 0.1695)
+(0.0000 0.0165 0.1695)
+(0.0030 0.0165 0.1695)
+(0.0060 0.0165 0.1695)
+(-0.0060 0.0195 0.1695)
+(-0.0030 0.0195 0.1695)
+(0.0000 0.0195 0.1695)
+(0.0030 0.0195 0.1695)
+(0.0060 0.0195 0.1695)
+(-0.0060 0.0225 0.1695)
+(-0.0030 0.0225 0.1695)
+(0.0000 0.0225 0.1695)
+(0.0030 0.0225 0.1695)
+(0.0060 0.0225 0.1695)
+(-0.0060 0.0255 0.1695)
+(-0.0030 0.0255 0.1695)
+(0.0000 0.0255 0.1695)
+(0.0030 0.0255 0.1695)
+(0.0060 0.0255 0.1695)
+(-0.0060 0.0285 0.1695)
+(-0.0030 0.0285 0.1695)
+(0.0000 0.0285 0.1695)
+(0.0030 0.0285 0.1695)
+(0.0060 0.0285 0.1695)
+(-0.0060 0.0315 0.1695)
+(-0.0030 0.0315 0.1695)
+(0.0000 0.0315 0.1695)
+(0.0030 0.0315 0.1695)
+(0.0060 0.0315 0.1695)
+(-0.0060 0.0345 0.1695)
+(-0.0030 0.0345 0.1695)
+(0.0000 0.0345 0.1695)
+(0.0030 0.0345 0.1695)
+(0.0060 0.0345 0.1695)
+(-0.0060 0.0375 0.1695)
+(-0.0030 0.0375 0.1695)
+(0.0000 0.0375 0.1695)
+(0.0030 0.0375 0.1695)
+(0.0060 0.0375 0.1695)
+(-0.0060 0.0405 0.1695)
+(-0.0030 0.0405 0.1695)
+(0.0000 0.0405 0.1695)
+(0.0030 0.0405 0.1695)
+(0.0060 0.0405 0.1695)
+(-0.0060 0.0435 0.1695)
+(-0.0030 0.0435 0.1695)
+(0.0000 0.0435 0.1695)
+(0.0030 0.0435 0.1695)
+(0.0060 0.0435 0.1695)
+(-0.0060 0.0465 0.1695)
+(-0.0030 0.0465 0.1695)
+(0.0000 0.0465 0.1695)
+(0.0030 0.0465 0.1695)
+(0.0060 0.0465 0.1695)
+(-0.0060 0.0495 0.1695)
+(-0.0030 0.0495 0.1695)
+(0.0000 0.0495 0.1695)
+(0.0030 0.0495 0.1695)
+(0.0060 0.0495 0.1695)
+(-0.0060 0.0525 0.1695)
+(-0.0030 0.0525 0.1695)
+(0.0000 0.0525 0.1695)
+(0.0030 0.0525 0.1695)
+(0.0060 0.0525 0.1695)
+(-0.0060 0.0555 0.1695)
+(-0.0030 0.0555 0.1695)
+(0.0000 0.0555 0.1695)
+(0.0030 0.0555 0.1695)
+(0.0060 0.0555 0.1695)
+(-0.0060 0.0585 0.1695)
+(-0.0030 0.0585 0.1695)
+(0.0000 0.0585 0.1695)
+(0.0030 0.0585 0.1695)
+(0.0060 0.0585 0.1695)
+(-0.0060 0.0615 0.1695)
+(-0.0030 0.0615 0.1695)
+(0.0000 0.0615 0.1695)
+(0.0030 0.0615 0.1695)
+(0.0060 0.0615 0.1695)
+(-0.0060 0.0645 0.1695)
+(-0.0030 0.0645 0.1695)
+(0.0000 0.0645 0.1695)
+(0.0030 0.0645 0.1695)
+(0.0060 0.0645 0.1695)
+(-0.0060 0.0675 0.1695)
+(-0.0030 0.0675 0.1695)
+(0.0000 0.0675 0.1695)
+(0.0030 0.0675 0.1695)
+(0.0060 0.0675 0.1695)
+(-0.0060 0.0705 0.1695)
+(-0.0030 0.0705 0.1695)
+(0.0000 0.0705 0.1695)
+(0.0030 0.0705 0.1695)
+(0.0060 0.0705 0.1695)
+(-0.0060 0.0735 0.1695)
+(-0.0030 0.0735 0.1695)
+(0.0000 0.0735 0.1695)
+(0.0030 0.0735 0.1695)
+(0.0060 0.0735 0.1695)
+(-0.0060 -0.0735 0.1725)
+(-0.0030 -0.0735 0.1725)
+(0.0000 -0.0735 0.1725)
+(0.0030 -0.0735 0.1725)
+(0.0060 -0.0735 0.1725)
+(-0.0060 -0.0705 0.1725)
+(-0.0030 -0.0705 0.1725)
+(0.0000 -0.0705 0.1725)
+(0.0030 -0.0705 0.1725)
+(0.0060 -0.0705 0.1725)
+(-0.0060 -0.0675 0.1725)
+(-0.0030 -0.0675 0.1725)
+(0.0000 -0.0675 0.1725)
+(0.0030 -0.0675 0.1725)
+(0.0060 -0.0675 0.1725)
+(-0.0060 -0.0645 0.1725)
+(-0.0030 -0.0645 0.1725)
+(0.0000 -0.0645 0.1725)
+(0.0030 -0.0645 0.1725)
+(0.0060 -0.0645 0.1725)
+(-0.0060 -0.0615 0.1725)
+(-0.0030 -0.0615 0.1725)
+(0.0000 -0.0615 0.1725)
+(0.0030 -0.0615 0.1725)
+(0.0060 -0.0615 0.1725)
+(-0.0060 -0.0585 0.1725)
+(-0.0030 -0.0585 0.1725)
+(0.0000 -0.0585 0.1725)
+(0.0030 -0.0585 0.1725)
+(0.0060 -0.0585 0.1725)
+(-0.0060 -0.0555 0.1725)
+(-0.0030 -0.0555 0.1725)
+(0.0000 -0.0555 0.1725)
+(0.0030 -0.0555 0.1725)
+(0.0060 -0.0555 0.1725)
+(-0.0060 -0.0525 0.1725)
+(-0.0030 -0.0525 0.1725)
+(0.0000 -0.0525 0.1725)
+(0.0030 -0.0525 0.1725)
+(0.0060 -0.0525 0.1725)
+(-0.0060 -0.0495 0.1725)
+(-0.0030 -0.0495 0.1725)
+(0.0000 -0.0495 0.1725)
+(0.0030 -0.0495 0.1725)
+(0.0060 -0.0495 0.1725)
+(-0.0060 -0.0465 0.1725)
+(-0.0030 -0.0465 0.1725)
+(0.0000 -0.0465 0.1725)
+(0.0030 -0.0465 0.1725)
+(0.0060 -0.0465 0.1725)
+(-0.0060 -0.0435 0.1725)
+(-0.0030 -0.0435 0.1725)
+(0.0000 -0.0435 0.1725)
+(0.0030 -0.0435 0.1725)
+(0.0060 -0.0435 0.1725)
+(-0.0060 -0.0405 0.1725)
+(-0.0030 -0.0405 0.1725)
+(0.0000 -0.0405 0.1725)
+(0.0030 -0.0405 0.1725)
+(0.0060 -0.0405 0.1725)
+(-0.0060 -0.0375 0.1725)
+(-0.0030 -0.0375 0.1725)
+(0.0000 -0.0375 0.1725)
+(0.0030 -0.0375 0.1725)
+(0.0060 -0.0375 0.1725)
+(-0.0060 -0.0345 0.1725)
+(-0.0030 -0.0345 0.1725)
+(0.0000 -0.0345 0.1725)
+(0.0030 -0.0345 0.1725)
+(0.0060 -0.0345 0.1725)
+(-0.0060 -0.0315 0.1725)
+(-0.0030 -0.0315 0.1725)
+(0.0000 -0.0315 0.1725)
+(0.0030 -0.0315 0.1725)
+(0.0060 -0.0315 0.1725)
+(-0.0060 -0.0285 0.1725)
+(-0.0030 -0.0285 0.1725)
+(0.0000 -0.0285 0.1725)
+(0.0030 -0.0285 0.1725)
+(0.0060 -0.0285 0.1725)
+(-0.0060 -0.0255 0.1725)
+(-0.0030 -0.0255 0.1725)
+(0.0000 -0.0255 0.1725)
+(0.0030 -0.0255 0.1725)
+(0.0060 -0.0255 0.1725)
+(-0.0060 -0.0225 0.1725)
+(-0.0030 -0.0225 0.1725)
+(0.0000 -0.0225 0.1725)
+(0.0030 -0.0225 0.1725)
+(0.0060 -0.0225 0.1725)
+(-0.0060 -0.0195 0.1725)
+(-0.0030 -0.0195 0.1725)
+(0.0000 -0.0195 0.1725)
+(0.0030 -0.0195 0.1725)
+(0.0060 -0.0195 0.1725)
+(-0.0060 -0.0165 0.1725)
+(-0.0030 -0.0165 0.1725)
+(0.0000 -0.0165 0.1725)
+(0.0030 -0.0165 0.1725)
+(0.0060 -0.0165 0.1725)
+(-0.0060 -0.0135 0.1725)
+(-0.0030 -0.0135 0.1725)
+(0.0000 -0.0135 0.1725)
+(0.0030 -0.0135 0.1725)
+(0.0060 -0.0135 0.1725)
+(-0.0060 -0.0105 0.1725)
+(-0.0030 -0.0105 0.1725)
+(0.0000 -0.0105 0.1725)
+(0.0030 -0.0105 0.1725)
+(0.0060 -0.0105 0.1725)
+(-0.0060 -0.0075 0.1725)
+(-0.0030 -0.0075 0.1725)
+(0.0000 -0.0075 0.1725)
+(0.0030 -0.0075 0.1725)
+(0.0060 -0.0075 0.1725)
+(-0.0060 -0.0045 0.1725)
+(-0.0030 -0.0045 0.1725)
+(0.0000 -0.0045 0.1725)
+(0.0030 -0.0045 0.1725)
+(0.0060 -0.0045 0.1725)
+(-0.0060 -0.0015 0.1725)
+(-0.0030 -0.0015 0.1725)
+(0.0000 -0.0015 0.1725)
+(0.0030 -0.0015 0.1725)
+(0.0060 -0.0015 0.1725)
+(-0.0060 0.0015 0.1725)
+(-0.0030 0.0015 0.1725)
+(0.0000 0.0015 0.1725)
+(0.0030 0.0015 0.1725)
+(0.0060 0.0015 0.1725)
+(-0.0060 0.0045 0.1725)
+(-0.0030 0.0045 0.1725)
+(0.0000 0.0045 0.1725)
+(0.0030 0.0045 0.1725)
+(0.0060 0.0045 0.1725)
+(-0.0060 0.0075 0.1725)
+(-0.0030 0.0075 0.1725)
+(0.0000 0.0075 0.1725)
+(0.0030 0.0075 0.1725)
+(0.0060 0.0075 0.1725)
+(-0.0060 0.0105 0.1725)
+(-0.0030 0.0105 0.1725)
+(0.0000 0.0105 0.1725)
+(0.0030 0.0105 0.1725)
+(0.0060 0.0105 0.1725)
+(-0.0060 0.0135 0.1725)
+(-0.0030 0.0135 0.1725)
+(0.0000 0.0135 0.1725)
+(0.0030 0.0135 0.1725)
+(0.0060 0.0135 0.1725)
+(-0.0060 0.0165 0.1725)
+(-0.0030 0.0165 0.1725)
+(0.0000 0.0165 0.1725)
+(0.0030 0.0165 0.1725)
+(0.0060 0.0165 0.1725)
+(-0.0060 0.0195 0.1725)
+(-0.0030 0.0195 0.1725)
+(0.0000 0.0195 0.1725)
+(0.0030 0.0195 0.1725)
+(0.0060 0.0195 0.1725)
+(-0.0060 0.0225 0.1725)
+(-0.0030 0.0225 0.1725)
+(0.0000 0.0225 0.1725)
+(0.0030 0.0225 0.1725)
+(0.0060 0.0225 0.1725)
+(-0.0060 0.0255 0.1725)
+(-0.0030 0.0255 0.1725)
+(0.0000 0.0255 0.1725)
+(0.0030 0.0255 0.1725)
+(0.0060 0.0255 0.1725)
+(-0.0060 0.0285 0.1725)
+(-0.0030 0.0285 0.1725)
+(0.0000 0.0285 0.1725)
+(0.0030 0.0285 0.1725)
+(0.0060 0.0285 0.1725)
+(-0.0060 0.0315 0.1725)
+(-0.0030 0.0315 0.1725)
+(0.0000 0.0315 0.1725)
+(0.0030 0.0315 0.1725)
+(0.0060 0.0315 0.1725)
+(-0.0060 0.0345 0.1725)
+(-0.0030 0.0345 0.1725)
+(0.0000 0.0345 0.1725)
+(0.0030 0.0345 0.1725)
+(0.0060 0.0345 0.1725)
+(-0.0060 0.0375 0.1725)
+(-0.0030 0.0375 0.1725)
+(0.0000 0.0375 0.1725)
+(0.0030 0.0375 0.1725)
+(0.0060 0.0375 0.1725)
+(-0.0060 0.0405 0.1725)
+(-0.0030 0.0405 0.1725)
+(0.0000 0.0405 0.1725)
+(0.0030 0.0405 0.1725)
+(0.0060 0.0405 0.1725)
+(-0.0060 0.0435 0.1725)
+(-0.0030 0.0435 0.1725)
+(0.0000 0.0435 0.1725)
+(0.0030 0.0435 0.1725)
+(0.0060 0.0435 0.1725)
+(-0.0060 0.0465 0.1725)
+(-0.0030 0.0465 0.1725)
+(0.0000 0.0465 0.1725)
+(0.0030 0.0465 0.1725)
+(0.0060 0.0465 0.1725)
+(-0.0060 0.0495 0.1725)
+(-0.0030 0.0495 0.1725)
+(0.0000 0.0495 0.1725)
+(0.0030 0.0495 0.1725)
+(0.0060 0.0495 0.1725)
+(-0.0060 0.0525 0.1725)
+(-0.0030 0.0525 0.1725)
+(0.0000 0.0525 0.1725)
+(0.0030 0.0525 0.1725)
+(0.0060 0.0525 0.1725)
+(-0.0060 0.0555 0.1725)
+(-0.0030 0.0555 0.1725)
+(0.0000 0.0555 0.1725)
+(0.0030 0.0555 0.1725)
+(0.0060 0.0555 0.1725)
+(-0.0060 0.0585 0.1725)
+(-0.0030 0.0585 0.1725)
+(0.0000 0.0585 0.1725)
+(0.0030 0.0585 0.1725)
+(0.0060 0.0585 0.1725)
+(-0.0060 0.0615 0.1725)
+(-0.0030 0.0615 0.1725)
+(0.0000 0.0615 0.1725)
+(0.0030 0.0615 0.1725)
+(0.0060 0.0615 0.1725)
+(-0.0060 0.0645 0.1725)
+(-0.0030 0.0645 0.1725)
+(0.0000 0.0645 0.1725)
+(0.0030 0.0645 0.1725)
+(0.0060 0.0645 0.1725)
+(-0.0060 0.0675 0.1725)
+(-0.0030 0.0675 0.1725)
+(0.0000 0.0675 0.1725)
+(0.0030 0.0675 0.1725)
+(0.0060 0.0675 0.1725)
+(-0.0060 0.0705 0.1725)
+(-0.0030 0.0705 0.1725)
+(0.0000 0.0705 0.1725)
+(0.0030 0.0705 0.1725)
+(0.0060 0.0705 0.1725)
+(-0.0060 0.0735 0.1725)
+(-0.0030 0.0735 0.1725)
+(0.0000 0.0735 0.1725)
+(0.0030 0.0735 0.1725)
+(0.0060 0.0735 0.1725)
+(-0.0060 -0.0735 0.1755)
+(-0.0030 -0.0735 0.1755)
+(0.0000 -0.0735 0.1755)
+(0.0030 -0.0735 0.1755)
+(0.0060 -0.0735 0.1755)
+(-0.0060 -0.0705 0.1755)
+(-0.0030 -0.0705 0.1755)
+(0.0000 -0.0705 0.1755)
+(0.0030 -0.0705 0.1755)
+(0.0060 -0.0705 0.1755)
+(-0.0060 -0.0675 0.1755)
+(-0.0030 -0.0675 0.1755)
+(0.0000 -0.0675 0.1755)
+(0.0030 -0.0675 0.1755)
+(0.0060 -0.0675 0.1755)
+(-0.0060 -0.0645 0.1755)
+(-0.0030 -0.0645 0.1755)
+(0.0000 -0.0645 0.1755)
+(0.0030 -0.0645 0.1755)
+(0.0060 -0.0645 0.1755)
+(-0.0060 -0.0615 0.1755)
+(-0.0030 -0.0615 0.1755)
+(0.0000 -0.0615 0.1755)
+(0.0030 -0.0615 0.1755)
+(0.0060 -0.0615 0.1755)
+(-0.0060 -0.0585 0.1755)
+(-0.0030 -0.0585 0.1755)
+(0.0000 -0.0585 0.1755)
+(0.0030 -0.0585 0.1755)
+(0.0060 -0.0585 0.1755)
+(-0.0060 -0.0555 0.1755)
+(-0.0030 -0.0555 0.1755)
+(0.0000 -0.0555 0.1755)
+(0.0030 -0.0555 0.1755)
+(0.0060 -0.0555 0.1755)
+(-0.0060 -0.0525 0.1755)
+(-0.0030 -0.0525 0.1755)
+(0.0000 -0.0525 0.1755)
+(0.0030 -0.0525 0.1755)
+(0.0060 -0.0525 0.1755)
+(-0.0060 -0.0495 0.1755)
+(-0.0030 -0.0495 0.1755)
+(0.0000 -0.0495 0.1755)
+(0.0030 -0.0495 0.1755)
+(0.0060 -0.0495 0.1755)
+(-0.0060 -0.0465 0.1755)
+(-0.0030 -0.0465 0.1755)
+(0.0000 -0.0465 0.1755)
+(0.0030 -0.0465 0.1755)
+(0.0060 -0.0465 0.1755)
+(-0.0060 -0.0435 0.1755)
+(-0.0030 -0.0435 0.1755)
+(0.0000 -0.0435 0.1755)
+(0.0030 -0.0435 0.1755)
+(0.0060 -0.0435 0.1755)
+(-0.0060 -0.0405 0.1755)
+(-0.0030 -0.0405 0.1755)
+(0.0000 -0.0405 0.1755)
+(0.0030 -0.0405 0.1755)
+(0.0060 -0.0405 0.1755)
+(-0.0060 -0.0375 0.1755)
+(-0.0030 -0.0375 0.1755)
+(0.0000 -0.0375 0.1755)
+(0.0030 -0.0375 0.1755)
+(0.0060 -0.0375 0.1755)
+(-0.0060 -0.0345 0.1755)
+(-0.0030 -0.0345 0.1755)
+(0.0000 -0.0345 0.1755)
+(0.0030 -0.0345 0.1755)
+(0.0060 -0.0345 0.1755)
+(-0.0060 -0.0315 0.1755)
+(-0.0030 -0.0315 0.1755)
+(0.0000 -0.0315 0.1755)
+(0.0030 -0.0315 0.1755)
+(0.0060 -0.0315 0.1755)
+(-0.0060 -0.0285 0.1755)
+(-0.0030 -0.0285 0.1755)
+(0.0000 -0.0285 0.1755)
+(0.0030 -0.0285 0.1755)
+(0.0060 -0.0285 0.1755)
+(-0.0060 -0.0255 0.1755)
+(-0.0030 -0.0255 0.1755)
+(0.0000 -0.0255 0.1755)
+(0.0030 -0.0255 0.1755)
+(0.0060 -0.0255 0.1755)
+(-0.0060 -0.0225 0.1755)
+(-0.0030 -0.0225 0.1755)
+(0.0000 -0.0225 0.1755)
+(0.0030 -0.0225 0.1755)
+(0.0060 -0.0225 0.1755)
+(-0.0060 -0.0195 0.1755)
+(-0.0030 -0.0195 0.1755)
+(0.0000 -0.0195 0.1755)
+(0.0030 -0.0195 0.1755)
+(0.0060 -0.0195 0.1755)
+(-0.0060 -0.0165 0.1755)
+(-0.0030 -0.0165 0.1755)
+(0.0000 -0.0165 0.1755)
+(0.0030 -0.0165 0.1755)
+(0.0060 -0.0165 0.1755)
+(-0.0060 -0.0135 0.1755)
+(-0.0030 -0.0135 0.1755)
+(0.0000 -0.0135 0.1755)
+(0.0030 -0.0135 0.1755)
+(0.0060 -0.0135 0.1755)
+(-0.0060 -0.0105 0.1755)
+(-0.0030 -0.0105 0.1755)
+(0.0000 -0.0105 0.1755)
+(0.0030 -0.0105 0.1755)
+(0.0060 -0.0105 0.1755)
+(-0.0060 -0.0075 0.1755)
+(-0.0030 -0.0075 0.1755)
+(0.0000 -0.0075 0.1755)
+(0.0030 -0.0075 0.1755)
+(0.0060 -0.0075 0.1755)
+(-0.0060 -0.0045 0.1755)
+(-0.0030 -0.0045 0.1755)
+(0.0000 -0.0045 0.1755)
+(0.0030 -0.0045 0.1755)
+(0.0060 -0.0045 0.1755)
+(-0.0060 -0.0015 0.1755)
+(-0.0030 -0.0015 0.1755)
+(0.0000 -0.0015 0.1755)
+(0.0030 -0.0015 0.1755)
+(0.0060 -0.0015 0.1755)
+(-0.0060 0.0015 0.1755)
+(-0.0030 0.0015 0.1755)
+(0.0000 0.0015 0.1755)
+(0.0030 0.0015 0.1755)
+(0.0060 0.0015 0.1755)
+(-0.0060 0.0045 0.1755)
+(-0.0030 0.0045 0.1755)
+(0.0000 0.0045 0.1755)
+(0.0030 0.0045 0.1755)
+(0.0060 0.0045 0.1755)
+(-0.0060 0.0075 0.1755)
+(-0.0030 0.0075 0.1755)
+(0.0000 0.0075 0.1755)
+(0.0030 0.0075 0.1755)
+(0.0060 0.0075 0.1755)
+(-0.0060 0.0105 0.1755)
+(-0.0030 0.0105 0.1755)
+(0.0000 0.0105 0.1755)
+(0.0030 0.0105 0.1755)
+(0.0060 0.0105 0.1755)
+(-0.0060 0.0135 0.1755)
+(-0.0030 0.0135 0.1755)
+(0.0000 0.0135 0.1755)
+(0.0030 0.0135 0.1755)
+(0.0060 0.0135 0.1755)
+(-0.0060 0.0165 0.1755)
+(-0.0030 0.0165 0.1755)
+(0.0000 0.0165 0.1755)
+(0.0030 0.0165 0.1755)
+(0.0060 0.0165 0.1755)
+(-0.0060 0.0195 0.1755)
+(-0.0030 0.0195 0.1755)
+(0.0000 0.0195 0.1755)
+(0.0030 0.0195 0.1755)
+(0.0060 0.0195 0.1755)
+(-0.0060 0.0225 0.1755)
+(-0.0030 0.0225 0.1755)
+(0.0000 0.0225 0.1755)
+(0.0030 0.0225 0.1755)
+(0.0060 0.0225 0.1755)
+(-0.0060 0.0255 0.1755)
+(-0.0030 0.0255 0.1755)
+(0.0000 0.0255 0.1755)
+(0.0030 0.0255 0.1755)
+(0.0060 0.0255 0.1755)
+(-0.0060 0.0285 0.1755)
+(-0.0030 0.0285 0.1755)
+(0.0000 0.0285 0.1755)
+(0.0030 0.0285 0.1755)
+(0.0060 0.0285 0.1755)
+(-0.0060 0.0315 0.1755)
+(-0.0030 0.0315 0.1755)
+(0.0000 0.0315 0.1755)
+(0.0030 0.0315 0.1755)
+(0.0060 0.0315 0.1755)
+(-0.0060 0.0345 0.1755)
+(-0.0030 0.0345 0.1755)
+(0.0000 0.0345 0.1755)
+(0.0030 0.0345 0.1755)
+(0.0060 0.0345 0.1755)
+(-0.0060 0.0375 0.1755)
+(-0.0030 0.0375 0.1755)
+(0.0000 0.0375 0.1755)
+(0.0030 0.0375 0.1755)
+(0.0060 0.0375 0.1755)
+(-0.0060 0.0405 0.1755)
+(-0.0030 0.0405 0.1755)
+(0.0000 0.0405 0.1755)
+(0.0030 0.0405 0.1755)
+(0.0060 0.0405 0.1755)
+(-0.0060 0.0435 0.1755)
+(-0.0030 0.0435 0.1755)
+(0.0000 0.0435 0.1755)
+(0.0030 0.0435 0.1755)
+(0.0060 0.0435 0.1755)
+(-0.0060 0.0465 0.1755)
+(-0.0030 0.0465 0.1755)
+(0.0000 0.0465 0.1755)
+(0.0030 0.0465 0.1755)
+(0.0060 0.0465 0.1755)
+(-0.0060 0.0495 0.1755)
+(-0.0030 0.0495 0.1755)
+(0.0000 0.0495 0.1755)
+(0.0030 0.0495 0.1755)
+(0.0060 0.0495 0.1755)
+(-0.0060 0.0525 0.1755)
+(-0.0030 0.0525 0.1755)
+(0.0000 0.0525 0.1755)
+(0.0030 0.0525 0.1755)
+(0.0060 0.0525 0.1755)
+(-0.0060 0.0555 0.1755)
+(-0.0030 0.0555 0.1755)
+(0.0000 0.0555 0.1755)
+(0.0030 0.0555 0.1755)
+(0.0060 0.0555 0.1755)
+(-0.0060 0.0585 0.1755)
+(-0.0030 0.0585 0.1755)
+(0.0000 0.0585 0.1755)
+(0.0030 0.0585 0.1755)
+(0.0060 0.0585 0.1755)
+(-0.0060 0.0615 0.1755)
+(-0.0030 0.0615 0.1755)
+(0.0000 0.0615 0.1755)
+(0.0030 0.0615 0.1755)
+(0.0060 0.0615 0.1755)
+(-0.0060 0.0645 0.1755)
+(-0.0030 0.0645 0.1755)
+(0.0000 0.0645 0.1755)
+(0.0030 0.0645 0.1755)
+(0.0060 0.0645 0.1755)
+(-0.0060 0.0675 0.1755)
+(-0.0030 0.0675 0.1755)
+(0.0000 0.0675 0.1755)
+(0.0030 0.0675 0.1755)
+(0.0060 0.0675 0.1755)
+(-0.0060 0.0705 0.1755)
+(-0.0030 0.0705 0.1755)
+(0.0000 0.0705 0.1755)
+(0.0030 0.0705 0.1755)
+(0.0060 0.0705 0.1755)
+(-0.0060 0.0735 0.1755)
+(-0.0030 0.0735 0.1755)
+(0.0000 0.0735 0.1755)
+(0.0030 0.0735 0.1755)
+(0.0060 0.0735 0.1755)
+(-0.0060 -0.0735 0.1785)
+(-0.0030 -0.0735 0.1785)
+(0.0000 -0.0735 0.1785)
+(0.0030 -0.0735 0.1785)
+(0.0060 -0.0735 0.1785)
+(-0.0060 -0.0705 0.1785)
+(-0.0030 -0.0705 0.1785)
+(0.0000 -0.0705 0.1785)
+(0.0030 -0.0705 0.1785)
+(0.0060 -0.0705 0.1785)
+(-0.0060 -0.0675 0.1785)
+(-0.0030 -0.0675 0.1785)
+(0.0000 -0.0675 0.1785)
+(0.0030 -0.0675 0.1785)
+(0.0060 -0.0675 0.1785)
+(-0.0060 -0.0645 0.1785)
+(-0.0030 -0.0645 0.1785)
+(0.0000 -0.0645 0.1785)
+(0.0030 -0.0645 0.1785)
+(0.0060 -0.0645 0.1785)
+(-0.0060 -0.0615 0.1785)
+(-0.0030 -0.0615 0.1785)
+(0.0000 -0.0615 0.1785)
+(0.0030 -0.0615 0.1785)
+(0.0060 -0.0615 0.1785)
+(-0.0060 -0.0585 0.1785)
+(-0.0030 -0.0585 0.1785)
+(0.0000 -0.0585 0.1785)
+(0.0030 -0.0585 0.1785)
+(0.0060 -0.0585 0.1785)
+(-0.0060 -0.0555 0.1785)
+(-0.0030 -0.0555 0.1785)
+(0.0000 -0.0555 0.1785)
+(0.0030 -0.0555 0.1785)
+(0.0060 -0.0555 0.1785)
+(-0.0060 -0.0525 0.1785)
+(-0.0030 -0.0525 0.1785)
+(0.0000 -0.0525 0.1785)
+(0.0030 -0.0525 0.1785)
+(0.0060 -0.0525 0.1785)
+(-0.0060 -0.0495 0.1785)
+(-0.0030 -0.0495 0.1785)
+(0.0000 -0.0495 0.1785)
+(0.0030 -0.0495 0.1785)
+(0.0060 -0.0495 0.1785)
+(-0.0060 -0.0465 0.1785)
+(-0.0030 -0.0465 0.1785)
+(0.0000 -0.0465 0.1785)
+(0.0030 -0.0465 0.1785)
+(0.0060 -0.0465 0.1785)
+(-0.0060 -0.0435 0.1785)
+(-0.0030 -0.0435 0.1785)
+(0.0000 -0.0435 0.1785)
+(0.0030 -0.0435 0.1785)
+(0.0060 -0.0435 0.1785)
+(-0.0060 -0.0405 0.1785)
+(-0.0030 -0.0405 0.1785)
+(0.0000 -0.0405 0.1785)
+(0.0030 -0.0405 0.1785)
+(0.0060 -0.0405 0.1785)
+(-0.0060 -0.0375 0.1785)
+(-0.0030 -0.0375 0.1785)
+(0.0000 -0.0375 0.1785)
+(0.0030 -0.0375 0.1785)
+(0.0060 -0.0375 0.1785)
+(-0.0060 -0.0345 0.1785)
+(-0.0030 -0.0345 0.1785)
+(0.0000 -0.0345 0.1785)
+(0.0030 -0.0345 0.1785)
+(0.0060 -0.0345 0.1785)
+(-0.0060 -0.0315 0.1785)
+(-0.0030 -0.0315 0.1785)
+(0.0000 -0.0315 0.1785)
+(0.0030 -0.0315 0.1785)
+(0.0060 -0.0315 0.1785)
+(-0.0060 -0.0285 0.1785)
+(-0.0030 -0.0285 0.1785)
+(0.0000 -0.0285 0.1785)
+(0.0030 -0.0285 0.1785)
+(0.0060 -0.0285 0.1785)
+(-0.0060 -0.0255 0.1785)
+(-0.0030 -0.0255 0.1785)
+(0.0000 -0.0255 0.1785)
+(0.0030 -0.0255 0.1785)
+(0.0060 -0.0255 0.1785)
+(-0.0060 -0.0225 0.1785)
+(-0.0030 -0.0225 0.1785)
+(0.0000 -0.0225 0.1785)
+(0.0030 -0.0225 0.1785)
+(0.0060 -0.0225 0.1785)
+(-0.0060 -0.0195 0.1785)
+(-0.0030 -0.0195 0.1785)
+(0.0000 -0.0195 0.1785)
+(0.0030 -0.0195 0.1785)
+(0.0060 -0.0195 0.1785)
+(-0.0060 -0.0165 0.1785)
+(-0.0030 -0.0165 0.1785)
+(0.0000 -0.0165 0.1785)
+(0.0030 -0.0165 0.1785)
+(0.0060 -0.0165 0.1785)
+(-0.0060 -0.0135 0.1785)
+(-0.0030 -0.0135 0.1785)
+(0.0000 -0.0135 0.1785)
+(0.0030 -0.0135 0.1785)
+(0.0060 -0.0135 0.1785)
+(-0.0060 -0.0105 0.1785)
+(-0.0030 -0.0105 0.1785)
+(0.0000 -0.0105 0.1785)
+(0.0030 -0.0105 0.1785)
+(0.0060 -0.0105 0.1785)
+(-0.0060 -0.0075 0.1785)
+(-0.0030 -0.0075 0.1785)
+(0.0000 -0.0075 0.1785)
+(0.0030 -0.0075 0.1785)
+(0.0060 -0.0075 0.1785)
+(-0.0060 -0.0045 0.1785)
+(-0.0030 -0.0045 0.1785)
+(0.0000 -0.0045 0.1785)
+(0.0030 -0.0045 0.1785)
+(0.0060 -0.0045 0.1785)
+(-0.0060 -0.0015 0.1785)
+(-0.0030 -0.0015 0.1785)
+(0.0000 -0.0015 0.1785)
+(0.0030 -0.0015 0.1785)
+(0.0060 -0.0015 0.1785)
+(-0.0060 0.0015 0.1785)
+(-0.0030 0.0015 0.1785)
+(0.0000 0.0015 0.1785)
+(0.0030 0.0015 0.1785)
+(0.0060 0.0015 0.1785)
+(-0.0060 0.0045 0.1785)
+(-0.0030 0.0045 0.1785)
+(0.0000 0.0045 0.1785)
+(0.0030 0.0045 0.1785)
+(0.0060 0.0045 0.1785)
+(-0.0060 0.0075 0.1785)
+(-0.0030 0.0075 0.1785)
+(0.0000 0.0075 0.1785)
+(0.0030 0.0075 0.1785)
+(0.0060 0.0075 0.1785)
+(-0.0060 0.0105 0.1785)
+(-0.0030 0.0105 0.1785)
+(0.0000 0.0105 0.1785)
+(0.0030 0.0105 0.1785)
+(0.0060 0.0105 0.1785)
+(-0.0060 0.0135 0.1785)
+(-0.0030 0.0135 0.1785)
+(0.0000 0.0135 0.1785)
+(0.0030 0.0135 0.1785)
+(0.0060 0.0135 0.1785)
+(-0.0060 0.0165 0.1785)
+(-0.0030 0.0165 0.1785)
+(0.0000 0.0165 0.1785)
+(0.0030 0.0165 0.1785)
+(0.0060 0.0165 0.1785)
+(-0.0060 0.0195 0.1785)
+(-0.0030 0.0195 0.1785)
+(0.0000 0.0195 0.1785)
+(0.0030 0.0195 0.1785)
+(0.0060 0.0195 0.1785)
+(-0.0060 0.0225 0.1785)
+(-0.0030 0.0225 0.1785)
+(0.0000 0.0225 0.1785)
+(0.0030 0.0225 0.1785)
+(0.0060 0.0225 0.1785)
+(-0.0060 0.0255 0.1785)
+(-0.0030 0.0255 0.1785)
+(0.0000 0.0255 0.1785)
+(0.0030 0.0255 0.1785)
+(0.0060 0.0255 0.1785)
+(-0.0060 0.0285 0.1785)
+(-0.0030 0.0285 0.1785)
+(0.0000 0.0285 0.1785)
+(0.0030 0.0285 0.1785)
+(0.0060 0.0285 0.1785)
+(-0.0060 0.0315 0.1785)
+(-0.0030 0.0315 0.1785)
+(0.0000 0.0315 0.1785)
+(0.0030 0.0315 0.1785)
+(0.0060 0.0315 0.1785)
+(-0.0060 0.0345 0.1785)
+(-0.0030 0.0345 0.1785)
+(0.0000 0.0345 0.1785)
+(0.0030 0.0345 0.1785)
+(0.0060 0.0345 0.1785)
+(-0.0060 0.0375 0.1785)
+(-0.0030 0.0375 0.1785)
+(0.0000 0.0375 0.1785)
+(0.0030 0.0375 0.1785)
+(0.0060 0.0375 0.1785)
+(-0.0060 0.0405 0.1785)
+(-0.0030 0.0405 0.1785)
+(0.0000 0.0405 0.1785)
+(0.0030 0.0405 0.1785)
+(0.0060 0.0405 0.1785)
+(-0.0060 0.0435 0.1785)
+(-0.0030 0.0435 0.1785)
+(0.0000 0.0435 0.1785)
+(0.0030 0.0435 0.1785)
+(0.0060 0.0435 0.1785)
+(-0.0060 0.0465 0.1785)
+(-0.0030 0.0465 0.1785)
+(0.0000 0.0465 0.1785)
+(0.0030 0.0465 0.1785)
+(0.0060 0.0465 0.1785)
+(-0.0060 0.0495 0.1785)
+(-0.0030 0.0495 0.1785)
+(0.0000 0.0495 0.1785)
+(0.0030 0.0495 0.1785)
+(0.0060 0.0495 0.1785)
+(-0.0060 0.0525 0.1785)
+(-0.0030 0.0525 0.1785)
+(0.0000 0.0525 0.1785)
+(0.0030 0.0525 0.1785)
+(0.0060 0.0525 0.1785)
+(-0.0060 0.0555 0.1785)
+(-0.0030 0.0555 0.1785)
+(0.0000 0.0555 0.1785)
+(0.0030 0.0555 0.1785)
+(0.0060 0.0555 0.1785)
+(-0.0060 0.0585 0.1785)
+(-0.0030 0.0585 0.1785)
+(0.0000 0.0585 0.1785)
+(0.0030 0.0585 0.1785)
+(0.0060 0.0585 0.1785)
+(-0.0060 0.0615 0.1785)
+(-0.0030 0.0615 0.1785)
+(0.0000 0.0615 0.1785)
+(0.0030 0.0615 0.1785)
+(0.0060 0.0615 0.1785)
+(-0.0060 0.0645 0.1785)
+(-0.0030 0.0645 0.1785)
+(0.0000 0.0645 0.1785)
+(0.0030 0.0645 0.1785)
+(0.0060 0.0645 0.1785)
+(-0.0060 0.0675 0.1785)
+(-0.0030 0.0675 0.1785)
+(0.0000 0.0675 0.1785)
+(0.0030 0.0675 0.1785)
+(0.0060 0.0675 0.1785)
+(-0.0060 0.0705 0.1785)
+(-0.0030 0.0705 0.1785)
+(0.0000 0.0705 0.1785)
+(0.0030 0.0705 0.1785)
+(0.0060 0.0705 0.1785)
+(-0.0060 0.0735 0.1785)
+(-0.0030 0.0735 0.1785)
+(0.0000 0.0735 0.1785)
+(0.0030 0.0735 0.1785)
+(0.0060 0.0735 0.1785)
+(-0.0060 -0.0735 0.1815)
+(-0.0030 -0.0735 0.1815)
+(0.0000 -0.0735 0.1815)
+(0.0030 -0.0735 0.1815)
+(0.0060 -0.0735 0.1815)
+(-0.0060 -0.0705 0.1815)
+(-0.0030 -0.0705 0.1815)
+(0.0000 -0.0705 0.1815)
+(0.0030 -0.0705 0.1815)
+(0.0060 -0.0705 0.1815)
+(-0.0060 -0.0675 0.1815)
+(-0.0030 -0.0675 0.1815)
+(0.0000 -0.0675 0.1815)
+(0.0030 -0.0675 0.1815)
+(0.0060 -0.0675 0.1815)
+(-0.0060 -0.0645 0.1815)
+(-0.0030 -0.0645 0.1815)
+(0.0000 -0.0645 0.1815)
+(0.0030 -0.0645 0.1815)
+(0.0060 -0.0645 0.1815)
+(-0.0060 -0.0615 0.1815)
+(-0.0030 -0.0615 0.1815)
+(0.0000 -0.0615 0.1815)
+(0.0030 -0.0615 0.1815)
+(0.0060 -0.0615 0.1815)
+(-0.0060 -0.0585 0.1815)
+(-0.0030 -0.0585 0.1815)
+(0.0000 -0.0585 0.1815)
+(0.0030 -0.0585 0.1815)
+(0.0060 -0.0585 0.1815)
+(-0.0060 -0.0555 0.1815)
+(-0.0030 -0.0555 0.1815)
+(0.0000 -0.0555 0.1815)
+(0.0030 -0.0555 0.1815)
+(0.0060 -0.0555 0.1815)
+(-0.0060 -0.0525 0.1815)
+(-0.0030 -0.0525 0.1815)
+(0.0000 -0.0525 0.1815)
+(0.0030 -0.0525 0.1815)
+(0.0060 -0.0525 0.1815)
+(-0.0060 -0.0495 0.1815)
+(-0.0030 -0.0495 0.1815)
+(0.0000 -0.0495 0.1815)
+(0.0030 -0.0495 0.1815)
+(0.0060 -0.0495 0.1815)
+(-0.0060 -0.0465 0.1815)
+(-0.0030 -0.0465 0.1815)
+(0.0000 -0.0465 0.1815)
+(0.0030 -0.0465 0.1815)
+(0.0060 -0.0465 0.1815)
+(-0.0060 -0.0435 0.1815)
+(-0.0030 -0.0435 0.1815)
+(0.0000 -0.0435 0.1815)
+(0.0030 -0.0435 0.1815)
+(0.0060 -0.0435 0.1815)
+(-0.0060 -0.0405 0.1815)
+(-0.0030 -0.0405 0.1815)
+(0.0000 -0.0405 0.1815)
+(0.0030 -0.0405 0.1815)
+(0.0060 -0.0405 0.1815)
+(-0.0060 -0.0375 0.1815)
+(-0.0030 -0.0375 0.1815)
+(0.0000 -0.0375 0.1815)
+(0.0030 -0.0375 0.1815)
+(0.0060 -0.0375 0.1815)
+(-0.0060 -0.0345 0.1815)
+(-0.0030 -0.0345 0.1815)
+(0.0000 -0.0345 0.1815)
+(0.0030 -0.0345 0.1815)
+(0.0060 -0.0345 0.1815)
+(-0.0060 -0.0315 0.1815)
+(-0.0030 -0.0315 0.1815)
+(0.0000 -0.0315 0.1815)
+(0.0030 -0.0315 0.1815)
+(0.0060 -0.0315 0.1815)
+(-0.0060 -0.0285 0.1815)
+(-0.0030 -0.0285 0.1815)
+(0.0000 -0.0285 0.1815)
+(0.0030 -0.0285 0.1815)
+(0.0060 -0.0285 0.1815)
+(-0.0060 -0.0255 0.1815)
+(-0.0030 -0.0255 0.1815)
+(0.0000 -0.0255 0.1815)
+(0.0030 -0.0255 0.1815)
+(0.0060 -0.0255 0.1815)
+(-0.0060 -0.0225 0.1815)
+(-0.0030 -0.0225 0.1815)
+(0.0000 -0.0225 0.1815)
+(0.0030 -0.0225 0.1815)
+(0.0060 -0.0225 0.1815)
+(-0.0060 -0.0195 0.1815)
+(-0.0030 -0.0195 0.1815)
+(0.0000 -0.0195 0.1815)
+(0.0030 -0.0195 0.1815)
+(0.0060 -0.0195 0.1815)
+(-0.0060 -0.0165 0.1815)
+(-0.0030 -0.0165 0.1815)
+(0.0000 -0.0165 0.1815)
+(0.0030 -0.0165 0.1815)
+(0.0060 -0.0165 0.1815)
+(-0.0060 -0.0135 0.1815)
+(-0.0030 -0.0135 0.1815)
+(0.0000 -0.0135 0.1815)
+(0.0030 -0.0135 0.1815)
+(0.0060 -0.0135 0.1815)
+(-0.0060 -0.0105 0.1815)
+(-0.0030 -0.0105 0.1815)
+(0.0000 -0.0105 0.1815)
+(0.0030 -0.0105 0.1815)
+(0.0060 -0.0105 0.1815)
+(-0.0060 -0.0075 0.1815)
+(-0.0030 -0.0075 0.1815)
+(0.0000 -0.0075 0.1815)
+(0.0030 -0.0075 0.1815)
+(0.0060 -0.0075 0.1815)
+(-0.0060 -0.0045 0.1815)
+(-0.0030 -0.0045 0.1815)
+(0.0000 -0.0045 0.1815)
+(0.0030 -0.0045 0.1815)
+(0.0060 -0.0045 0.1815)
+(-0.0060 -0.0015 0.1815)
+(-0.0030 -0.0015 0.1815)
+(0.0000 -0.0015 0.1815)
+(0.0030 -0.0015 0.1815)
+(0.0060 -0.0015 0.1815)
+(-0.0060 0.0015 0.1815)
+(-0.0030 0.0015 0.1815)
+(0.0000 0.0015 0.1815)
+(0.0030 0.0015 0.1815)
+(0.0060 0.0015 0.1815)
+(-0.0060 0.0045 0.1815)
+(-0.0030 0.0045 0.1815)
+(0.0000 0.0045 0.1815)
+(0.0030 0.0045 0.1815)
+(0.0060 0.0045 0.1815)
+(-0.0060 0.0075 0.1815)
+(-0.0030 0.0075 0.1815)
+(0.0000 0.0075 0.1815)
+(0.0030 0.0075 0.1815)
+(0.0060 0.0075 0.1815)
+(-0.0060 0.0105 0.1815)
+(-0.0030 0.0105 0.1815)
+(0.0000 0.0105 0.1815)
+(0.0030 0.0105 0.1815)
+(0.0060 0.0105 0.1815)
+(-0.0060 0.0135 0.1815)
+(-0.0030 0.0135 0.1815)
+(0.0000 0.0135 0.1815)
+(0.0030 0.0135 0.1815)
+(0.0060 0.0135 0.1815)
+(-0.0060 0.0165 0.1815)
+(-0.0030 0.0165 0.1815)
+(0.0000 0.0165 0.1815)
+(0.0030 0.0165 0.1815)
+(0.0060 0.0165 0.1815)
+(-0.0060 0.0195 0.1815)
+(-0.0030 0.0195 0.1815)
+(0.0000 0.0195 0.1815)
+(0.0030 0.0195 0.1815)
+(0.0060 0.0195 0.1815)
+(-0.0060 0.0225 0.1815)
+(-0.0030 0.0225 0.1815)
+(0.0000 0.0225 0.1815)
+(0.0030 0.0225 0.1815)
+(0.0060 0.0225 0.1815)
+(-0.0060 0.0255 0.1815)
+(-0.0030 0.0255 0.1815)
+(0.0000 0.0255 0.1815)
+(0.0030 0.0255 0.1815)
+(0.0060 0.0255 0.1815)
+(-0.0060 0.0285 0.1815)
+(-0.0030 0.0285 0.1815)
+(0.0000 0.0285 0.1815)
+(0.0030 0.0285 0.1815)
+(0.0060 0.0285 0.1815)
+(-0.0060 0.0315 0.1815)
+(-0.0030 0.0315 0.1815)
+(0.0000 0.0315 0.1815)
+(0.0030 0.0315 0.1815)
+(0.0060 0.0315 0.1815)
+(-0.0060 0.0345 0.1815)
+(-0.0030 0.0345 0.1815)
+(0.0000 0.0345 0.1815)
+(0.0030 0.0345 0.1815)
+(0.0060 0.0345 0.1815)
+(-0.0060 0.0375 0.1815)
+(-0.0030 0.0375 0.1815)
+(0.0000 0.0375 0.1815)
+(0.0030 0.0375 0.1815)
+(0.0060 0.0375 0.1815)
+(-0.0060 0.0405 0.1815)
+(-0.0030 0.0405 0.1815)
+(0.0000 0.0405 0.1815)
+(0.0030 0.0405 0.1815)
+(0.0060 0.0405 0.1815)
+(-0.0060 0.0435 0.1815)
+(-0.0030 0.0435 0.1815)
+(0.0000 0.0435 0.1815)
+(0.0030 0.0435 0.1815)
+(0.0060 0.0435 0.1815)
+(-0.0060 0.0465 0.1815)
+(-0.0030 0.0465 0.1815)
+(0.0000 0.0465 0.1815)
+(0.0030 0.0465 0.1815)
+(0.0060 0.0465 0.1815)
+(-0.0060 0.0495 0.1815)
+(-0.0030 0.0495 0.1815)
+(0.0000 0.0495 0.1815)
+(0.0030 0.0495 0.1815)
+(0.0060 0.0495 0.1815)
+(-0.0060 0.0525 0.1815)
+(-0.0030 0.0525 0.1815)
+(0.0000 0.0525 0.1815)
+(0.0030 0.0525 0.1815)
+(0.0060 0.0525 0.1815)
+(-0.0060 0.0555 0.1815)
+(-0.0030 0.0555 0.1815)
+(0.0000 0.0555 0.1815)
+(0.0030 0.0555 0.1815)
+(0.0060 0.0555 0.1815)
+(-0.0060 0.0585 0.1815)
+(-0.0030 0.0585 0.1815)
+(0.0000 0.0585 0.1815)
+(0.0030 0.0585 0.1815)
+(0.0060 0.0585 0.1815)
+(-0.0060 0.0615 0.1815)
+(-0.0030 0.0615 0.1815)
+(0.0000 0.0615 0.1815)
+(0.0030 0.0615 0.1815)
+(0.0060 0.0615 0.1815)
+(-0.0060 0.0645 0.1815)
+(-0.0030 0.0645 0.1815)
+(0.0000 0.0645 0.1815)
+(0.0030 0.0645 0.1815)
+(0.0060 0.0645 0.1815)
+(-0.0060 0.0675 0.1815)
+(-0.0030 0.0675 0.1815)
+(0.0000 0.0675 0.1815)
+(0.0030 0.0675 0.1815)
+(0.0060 0.0675 0.1815)
+(-0.0060 0.0705 0.1815)
+(-0.0030 0.0705 0.1815)
+(0.0000 0.0705 0.1815)
+(0.0030 0.0705 0.1815)
+(0.0060 0.0705 0.1815)
+(-0.0060 0.0735 0.1815)
+(-0.0030 0.0735 0.1815)
+(0.0000 0.0735 0.1815)
+(0.0030 0.0735 0.1815)
+(0.0060 0.0735 0.1815)
+(-0.0060 -0.0735 0.1845)
+(-0.0030 -0.0735 0.1845)
+(0.0000 -0.0735 0.1845)
+(0.0030 -0.0735 0.1845)
+(0.0060 -0.0735 0.1845)
+(-0.0060 -0.0705 0.1845)
+(-0.0030 -0.0705 0.1845)
+(0.0000 -0.0705 0.1845)
+(0.0030 -0.0705 0.1845)
+(0.0060 -0.0705 0.1845)
+(-0.0060 -0.0675 0.1845)
+(-0.0030 -0.0675 0.1845)
+(0.0000 -0.0675 0.1845)
+(0.0030 -0.0675 0.1845)
+(0.0060 -0.0675 0.1845)
+(-0.0060 -0.0645 0.1845)
+(-0.0030 -0.0645 0.1845)
+(0.0000 -0.0645 0.1845)
+(0.0030 -0.0645 0.1845)
+(0.0060 -0.0645 0.1845)
+(-0.0060 -0.0615 0.1845)
+(-0.0030 -0.0615 0.1845)
+(0.0000 -0.0615 0.1845)
+(0.0030 -0.0615 0.1845)
+(0.0060 -0.0615 0.1845)
+(-0.0060 -0.0585 0.1845)
+(-0.0030 -0.0585 0.1845)
+(0.0000 -0.0585 0.1845)
+(0.0030 -0.0585 0.1845)
+(0.0060 -0.0585 0.1845)
+(-0.0060 -0.0555 0.1845)
+(-0.0030 -0.0555 0.1845)
+(0.0000 -0.0555 0.1845)
+(0.0030 -0.0555 0.1845)
+(0.0060 -0.0555 0.1845)
+(-0.0060 -0.0525 0.1845)
+(-0.0030 -0.0525 0.1845)
+(0.0000 -0.0525 0.1845)
+(0.0030 -0.0525 0.1845)
+(0.0060 -0.0525 0.1845)
+(-0.0060 -0.0495 0.1845)
+(-0.0030 -0.0495 0.1845)
+(0.0000 -0.0495 0.1845)
+(0.0030 -0.0495 0.1845)
+(0.0060 -0.0495 0.1845)
+(-0.0060 -0.0465 0.1845)
+(-0.0030 -0.0465 0.1845)
+(0.0000 -0.0465 0.1845)
+(0.0030 -0.0465 0.1845)
+(0.0060 -0.0465 0.1845)
+(-0.0060 -0.0435 0.1845)
+(-0.0030 -0.0435 0.1845)
+(0.0000 -0.0435 0.1845)
+(0.0030 -0.0435 0.1845)
+(0.0060 -0.0435 0.1845)
+(-0.0060 -0.0405 0.1845)
+(-0.0030 -0.0405 0.1845)
+(0.0000 -0.0405 0.1845)
+(0.0030 -0.0405 0.1845)
+(0.0060 -0.0405 0.1845)
+(-0.0060 -0.0375 0.1845)
+(-0.0030 -0.0375 0.1845)
+(0.0000 -0.0375 0.1845)
+(0.0030 -0.0375 0.1845)
+(0.0060 -0.0375 0.1845)
+(-0.0060 -0.0345 0.1845)
+(-0.0030 -0.0345 0.1845)
+(0.0000 -0.0345 0.1845)
+(0.0030 -0.0345 0.1845)
+(0.0060 -0.0345 0.1845)
+(-0.0060 -0.0315 0.1845)
+(-0.0030 -0.0315 0.1845)
+(0.0000 -0.0315 0.1845)
+(0.0030 -0.0315 0.1845)
+(0.0060 -0.0315 0.1845)
+(-0.0060 -0.0285 0.1845)
+(-0.0030 -0.0285 0.1845)
+(0.0000 -0.0285 0.1845)
+(0.0030 -0.0285 0.1845)
+(0.0060 -0.0285 0.1845)
+(-0.0060 -0.0255 0.1845)
+(-0.0030 -0.0255 0.1845)
+(0.0000 -0.0255 0.1845)
+(0.0030 -0.0255 0.1845)
+(0.0060 -0.0255 0.1845)
+(-0.0060 -0.0225 0.1845)
+(-0.0030 -0.0225 0.1845)
+(0.0000 -0.0225 0.1845)
+(0.0030 -0.0225 0.1845)
+(0.0060 -0.0225 0.1845)
+(-0.0060 -0.0195 0.1845)
+(-0.0030 -0.0195 0.1845)
+(0.0000 -0.0195 0.1845)
+(0.0030 -0.0195 0.1845)
+(0.0060 -0.0195 0.1845)
+(-0.0060 -0.0165 0.1845)
+(-0.0030 -0.0165 0.1845)
+(0.0000 -0.0165 0.1845)
+(0.0030 -0.0165 0.1845)
+(0.0060 -0.0165 0.1845)
+(-0.0060 -0.0135 0.1845)
+(-0.0030 -0.0135 0.1845)
+(0.0000 -0.0135 0.1845)
+(0.0030 -0.0135 0.1845)
+(0.0060 -0.0135 0.1845)
+(-0.0060 -0.0105 0.1845)
+(-0.0030 -0.0105 0.1845)
+(0.0000 -0.0105 0.1845)
+(0.0030 -0.0105 0.1845)
+(0.0060 -0.0105 0.1845)
+(-0.0060 -0.0075 0.1845)
+(-0.0030 -0.0075 0.1845)
+(0.0000 -0.0075 0.1845)
+(0.0030 -0.0075 0.1845)
+(0.0060 -0.0075 0.1845)
+(-0.0060 -0.0045 0.1845)
+(-0.0030 -0.0045 0.1845)
+(0.0000 -0.0045 0.1845)
+(0.0030 -0.0045 0.1845)
+(0.0060 -0.0045 0.1845)
+(-0.0060 -0.0015 0.1845)
+(-0.0030 -0.0015 0.1845)
+(0.0000 -0.0015 0.1845)
+(0.0030 -0.0015 0.1845)
+(0.0060 -0.0015 0.1845)
+(-0.0060 0.0015 0.1845)
+(-0.0030 0.0015 0.1845)
+(0.0000 0.0015 0.1845)
+(0.0030 0.0015 0.1845)
+(0.0060 0.0015 0.1845)
+(-0.0060 0.0045 0.1845)
+(-0.0030 0.0045 0.1845)
+(0.0000 0.0045 0.1845)
+(0.0030 0.0045 0.1845)
+(0.0060 0.0045 0.1845)
+(-0.0060 0.0075 0.1845)
+(-0.0030 0.0075 0.1845)
+(0.0000 0.0075 0.1845)
+(0.0030 0.0075 0.1845)
+(0.0060 0.0075 0.1845)
+(-0.0060 0.0105 0.1845)
+(-0.0030 0.0105 0.1845)
+(0.0000 0.0105 0.1845)
+(0.0030 0.0105 0.1845)
+(0.0060 0.0105 0.1845)
+(-0.0060 0.0135 0.1845)
+(-0.0030 0.0135 0.1845)
+(0.0000 0.0135 0.1845)
+(0.0030 0.0135 0.1845)
+(0.0060 0.0135 0.1845)
+(-0.0060 0.0165 0.1845)
+(-0.0030 0.0165 0.1845)
+(0.0000 0.0165 0.1845)
+(0.0030 0.0165 0.1845)
+(0.0060 0.0165 0.1845)
+(-0.0060 0.0195 0.1845)
+(-0.0030 0.0195 0.1845)
+(0.0000 0.0195 0.1845)
+(0.0030 0.0195 0.1845)
+(0.0060 0.0195 0.1845)
+(-0.0060 0.0225 0.1845)
+(-0.0030 0.0225 0.1845)
+(0.0000 0.0225 0.1845)
+(0.0030 0.0225 0.1845)
+(0.0060 0.0225 0.1845)
+(-0.0060 0.0255 0.1845)
+(-0.0030 0.0255 0.1845)
+(0.0000 0.0255 0.1845)
+(0.0030 0.0255 0.1845)
+(0.0060 0.0255 0.1845)
+(-0.0060 0.0285 0.1845)
+(-0.0030 0.0285 0.1845)
+(0.0000 0.0285 0.1845)
+(0.0030 0.0285 0.1845)
+(0.0060 0.0285 0.1845)
+(-0.0060 0.0315 0.1845)
+(-0.0030 0.0315 0.1845)
+(0.0000 0.0315 0.1845)
+(0.0030 0.0315 0.1845)
+(0.0060 0.0315 0.1845)
+(-0.0060 0.0345 0.1845)
+(-0.0030 0.0345 0.1845)
+(0.0000 0.0345 0.1845)
+(0.0030 0.0345 0.1845)
+(0.0060 0.0345 0.1845)
+(-0.0060 0.0375 0.1845)
+(-0.0030 0.0375 0.1845)
+(0.0000 0.0375 0.1845)
+(0.0030 0.0375 0.1845)
+(0.0060 0.0375 0.1845)
+(-0.0060 0.0405 0.1845)
+(-0.0030 0.0405 0.1845)
+(0.0000 0.0405 0.1845)
+(0.0030 0.0405 0.1845)
+(0.0060 0.0405 0.1845)
+(-0.0060 0.0435 0.1845)
+(-0.0030 0.0435 0.1845)
+(0.0000 0.0435 0.1845)
+(0.0030 0.0435 0.1845)
+(0.0060 0.0435 0.1845)
+(-0.0060 0.0465 0.1845)
+(-0.0030 0.0465 0.1845)
+(0.0000 0.0465 0.1845)
+(0.0030 0.0465 0.1845)
+(0.0060 0.0465 0.1845)
+(-0.0060 0.0495 0.1845)
+(-0.0030 0.0495 0.1845)
+(0.0000 0.0495 0.1845)
+(0.0030 0.0495 0.1845)
+(0.0060 0.0495 0.1845)
+(-0.0060 0.0525 0.1845)
+(-0.0030 0.0525 0.1845)
+(0.0000 0.0525 0.1845)
+(0.0030 0.0525 0.1845)
+(0.0060 0.0525 0.1845)
+(-0.0060 0.0555 0.1845)
+(-0.0030 0.0555 0.1845)
+(0.0000 0.0555 0.1845)
+(0.0030 0.0555 0.1845)
+(0.0060 0.0555 0.1845)
+(-0.0060 0.0585 0.1845)
+(-0.0030 0.0585 0.1845)
+(0.0000 0.0585 0.1845)
+(0.0030 0.0585 0.1845)
+(0.0060 0.0585 0.1845)
+(-0.0060 0.0615 0.1845)
+(-0.0030 0.0615 0.1845)
+(0.0000 0.0615 0.1845)
+(0.0030 0.0615 0.1845)
+(0.0060 0.0615 0.1845)
+(-0.0060 0.0645 0.1845)
+(-0.0030 0.0645 0.1845)
+(0.0000 0.0645 0.1845)
+(0.0030 0.0645 0.1845)
+(0.0060 0.0645 0.1845)
+(-0.0060 0.0675 0.1845)
+(-0.0030 0.0675 0.1845)
+(0.0000 0.0675 0.1845)
+(0.0030 0.0675 0.1845)
+(0.0060 0.0675 0.1845)
+(-0.0060 0.0705 0.1845)
+(-0.0030 0.0705 0.1845)
+(0.0000 0.0705 0.1845)
+(0.0030 0.0705 0.1845)
+(0.0060 0.0705 0.1845)
+(-0.0060 0.0735 0.1845)
+(-0.0030 0.0735 0.1845)
+(0.0000 0.0735 0.1845)
+(0.0030 0.0735 0.1845)
+(0.0060 0.0735 0.1845)
+(-0.0060 -0.0735 0.1875)
+(-0.0030 -0.0735 0.1875)
+(0.0000 -0.0735 0.1875)
+(0.0030 -0.0735 0.1875)
+(0.0060 -0.0735 0.1875)
+(-0.0060 -0.0705 0.1875)
+(-0.0030 -0.0705 0.1875)
+(0.0000 -0.0705 0.1875)
+(0.0030 -0.0705 0.1875)
+(0.0060 -0.0705 0.1875)
+(-0.0060 -0.0675 0.1875)
+(-0.0030 -0.0675 0.1875)
+(0.0000 -0.0675 0.1875)
+(0.0030 -0.0675 0.1875)
+(0.0060 -0.0675 0.1875)
+(-0.0060 -0.0645 0.1875)
+(-0.0030 -0.0645 0.1875)
+(0.0000 -0.0645 0.1875)
+(0.0030 -0.0645 0.1875)
+(0.0060 -0.0645 0.1875)
+(-0.0060 -0.0615 0.1875)
+(-0.0030 -0.0615 0.1875)
+(0.0000 -0.0615 0.1875)
+(0.0030 -0.0615 0.1875)
+(0.0060 -0.0615 0.1875)
+(-0.0060 -0.0585 0.1875)
+(-0.0030 -0.0585 0.1875)
+(0.0000 -0.0585 0.1875)
+(0.0030 -0.0585 0.1875)
+(0.0060 -0.0585 0.1875)
+(-0.0060 -0.0555 0.1875)
+(-0.0030 -0.0555 0.1875)
+(0.0000 -0.0555 0.1875)
+(0.0030 -0.0555 0.1875)
+(0.0060 -0.0555 0.1875)
+(-0.0060 -0.0525 0.1875)
+(-0.0030 -0.0525 0.1875)
+(0.0000 -0.0525 0.1875)
+(0.0030 -0.0525 0.1875)
+(0.0060 -0.0525 0.1875)
+(-0.0060 -0.0495 0.1875)
+(-0.0030 -0.0495 0.1875)
+(0.0000 -0.0495 0.1875)
+(0.0030 -0.0495 0.1875)
+(0.0060 -0.0495 0.1875)
+(-0.0060 -0.0465 0.1875)
+(-0.0030 -0.0465 0.1875)
+(0.0000 -0.0465 0.1875)
+(0.0030 -0.0465 0.1875)
+(0.0060 -0.0465 0.1875)
+(-0.0060 -0.0435 0.1875)
+(-0.0030 -0.0435 0.1875)
+(0.0000 -0.0435 0.1875)
+(0.0030 -0.0435 0.1875)
+(0.0060 -0.0435 0.1875)
+(-0.0060 -0.0405 0.1875)
+(-0.0030 -0.0405 0.1875)
+(0.0000 -0.0405 0.1875)
+(0.0030 -0.0405 0.1875)
+(0.0060 -0.0405 0.1875)
+(-0.0060 -0.0375 0.1875)
+(-0.0030 -0.0375 0.1875)
+(0.0000 -0.0375 0.1875)
+(0.0030 -0.0375 0.1875)
+(0.0060 -0.0375 0.1875)
+(-0.0060 -0.0345 0.1875)
+(-0.0030 -0.0345 0.1875)
+(0.0000 -0.0345 0.1875)
+(0.0030 -0.0345 0.1875)
+(0.0060 -0.0345 0.1875)
+(-0.0060 -0.0315 0.1875)
+(-0.0030 -0.0315 0.1875)
+(0.0000 -0.0315 0.1875)
+(0.0030 -0.0315 0.1875)
+(0.0060 -0.0315 0.1875)
+(-0.0060 -0.0285 0.1875)
+(-0.0030 -0.0285 0.1875)
+(0.0000 -0.0285 0.1875)
+(0.0030 -0.0285 0.1875)
+(0.0060 -0.0285 0.1875)
+(-0.0060 -0.0255 0.1875)
+(-0.0030 -0.0255 0.1875)
+(0.0000 -0.0255 0.1875)
+(0.0030 -0.0255 0.1875)
+(0.0060 -0.0255 0.1875)
+(-0.0060 -0.0225 0.1875)
+(-0.0030 -0.0225 0.1875)
+(0.0000 -0.0225 0.1875)
+(0.0030 -0.0225 0.1875)
+(0.0060 -0.0225 0.1875)
+(-0.0060 -0.0195 0.1875)
+(-0.0030 -0.0195 0.1875)
+(0.0000 -0.0195 0.1875)
+(0.0030 -0.0195 0.1875)
+(0.0060 -0.0195 0.1875)
+(-0.0060 -0.0165 0.1875)
+(-0.0030 -0.0165 0.1875)
+(0.0000 -0.0165 0.1875)
+(0.0030 -0.0165 0.1875)
+(0.0060 -0.0165 0.1875)
+(-0.0060 -0.0135 0.1875)
+(-0.0030 -0.0135 0.1875)
+(0.0000 -0.0135 0.1875)
+(0.0030 -0.0135 0.1875)
+(0.0060 -0.0135 0.1875)
+(-0.0060 -0.0105 0.1875)
+(-0.0030 -0.0105 0.1875)
+(0.0000 -0.0105 0.1875)
+(0.0030 -0.0105 0.1875)
+(0.0060 -0.0105 0.1875)
+(-0.0060 -0.0075 0.1875)
+(-0.0030 -0.0075 0.1875)
+(0.0000 -0.0075 0.1875)
+(0.0030 -0.0075 0.1875)
+(0.0060 -0.0075 0.1875)
+(-0.0060 -0.0045 0.1875)
+(-0.0030 -0.0045 0.1875)
+(0.0000 -0.0045 0.1875)
+(0.0030 -0.0045 0.1875)
+(0.0060 -0.0045 0.1875)
+(-0.0060 -0.0015 0.1875)
+(-0.0030 -0.0015 0.1875)
+(0.0000 -0.0015 0.1875)
+(0.0030 -0.0015 0.1875)
+(0.0060 -0.0015 0.1875)
+(-0.0060 0.0015 0.1875)
+(-0.0030 0.0015 0.1875)
+(0.0000 0.0015 0.1875)
+(0.0030 0.0015 0.1875)
+(0.0060 0.0015 0.1875)
+(-0.0060 0.0045 0.1875)
+(-0.0030 0.0045 0.1875)
+(0.0000 0.0045 0.1875)
+(0.0030 0.0045 0.1875)
+(0.0060 0.0045 0.1875)
+(-0.0060 0.0075 0.1875)
+(-0.0030 0.0075 0.1875)
+(0.0000 0.0075 0.1875)
+(0.0030 0.0075 0.1875)
+(0.0060 0.0075 0.1875)
+(-0.0060 0.0105 0.1875)
+(-0.0030 0.0105 0.1875)
+(0.0000 0.0105 0.1875)
+(0.0030 0.0105 0.1875)
+(0.0060 0.0105 0.1875)
+(-0.0060 0.0135 0.1875)
+(-0.0030 0.0135 0.1875)
+(0.0000 0.0135 0.1875)
+(0.0030 0.0135 0.1875)
+(0.0060 0.0135 0.1875)
+(-0.0060 0.0165 0.1875)
+(-0.0030 0.0165 0.1875)
+(0.0000 0.0165 0.1875)
+(0.0030 0.0165 0.1875)
+(0.0060 0.0165 0.1875)
+(-0.0060 0.0195 0.1875)
+(-0.0030 0.0195 0.1875)
+(0.0000 0.0195 0.1875)
+(0.0030 0.0195 0.1875)
+(0.0060 0.0195 0.1875)
+(-0.0060 0.0225 0.1875)
+(-0.0030 0.0225 0.1875)
+(0.0000 0.0225 0.1875)
+(0.0030 0.0225 0.1875)
+(0.0060 0.0225 0.1875)
+(-0.0060 0.0255 0.1875)
+(-0.0030 0.0255 0.1875)
+(0.0000 0.0255 0.1875)
+(0.0030 0.0255 0.1875)
+(0.0060 0.0255 0.1875)
+(-0.0060 0.0285 0.1875)
+(-0.0030 0.0285 0.1875)
+(0.0000 0.0285 0.1875)
+(0.0030 0.0285 0.1875)
+(0.0060 0.0285 0.1875)
+(-0.0060 0.0315 0.1875)
+(-0.0030 0.0315 0.1875)
+(0.0000 0.0315 0.1875)
+(0.0030 0.0315 0.1875)
+(0.0060 0.0315 0.1875)
+(-0.0060 0.0345 0.1875)
+(-0.0030 0.0345 0.1875)
+(0.0000 0.0345 0.1875)
+(0.0030 0.0345 0.1875)
+(0.0060 0.0345 0.1875)
+(-0.0060 0.0375 0.1875)
+(-0.0030 0.0375 0.1875)
+(0.0000 0.0375 0.1875)
+(0.0030 0.0375 0.1875)
+(0.0060 0.0375 0.1875)
+(-0.0060 0.0405 0.1875)
+(-0.0030 0.0405 0.1875)
+(0.0000 0.0405 0.1875)
+(0.0030 0.0405 0.1875)
+(0.0060 0.0405 0.1875)
+(-0.0060 0.0435 0.1875)
+(-0.0030 0.0435 0.1875)
+(0.0000 0.0435 0.1875)
+(0.0030 0.0435 0.1875)
+(0.0060 0.0435 0.1875)
+(-0.0060 0.0465 0.1875)
+(-0.0030 0.0465 0.1875)
+(0.0000 0.0465 0.1875)
+(0.0030 0.0465 0.1875)
+(0.0060 0.0465 0.1875)
+(-0.0060 0.0495 0.1875)
+(-0.0030 0.0495 0.1875)
+(0.0000 0.0495 0.1875)
+(0.0030 0.0495 0.1875)
+(0.0060 0.0495 0.1875)
+(-0.0060 0.0525 0.1875)
+(-0.0030 0.0525 0.1875)
+(0.0000 0.0525 0.1875)
+(0.0030 0.0525 0.1875)
+(0.0060 0.0525 0.1875)
+(-0.0060 0.0555 0.1875)
+(-0.0030 0.0555 0.1875)
+(0.0000 0.0555 0.1875)
+(0.0030 0.0555 0.1875)
+(0.0060 0.0555 0.1875)
+(-0.0060 0.0585 0.1875)
+(-0.0030 0.0585 0.1875)
+(0.0000 0.0585 0.1875)
+(0.0030 0.0585 0.1875)
+(0.0060 0.0585 0.1875)
+(-0.0060 0.0615 0.1875)
+(-0.0030 0.0615 0.1875)
+(0.0000 0.0615 0.1875)
+(0.0030 0.0615 0.1875)
+(0.0060 0.0615 0.1875)
+(-0.0060 0.0645 0.1875)
+(-0.0030 0.0645 0.1875)
+(0.0000 0.0645 0.1875)
+(0.0030 0.0645 0.1875)
+(0.0060 0.0645 0.1875)
+(-0.0060 0.0675 0.1875)
+(-0.0030 0.0675 0.1875)
+(0.0000 0.0675 0.1875)
+(0.0030 0.0675 0.1875)
+(0.0060 0.0675 0.1875)
+(-0.0060 0.0705 0.1875)
+(-0.0030 0.0705 0.1875)
+(0.0000 0.0705 0.1875)
+(0.0030 0.0705 0.1875)
+(0.0060 0.0705 0.1875)
+(-0.0060 0.0735 0.1875)
+(-0.0030 0.0735 0.1875)
+(0.0000 0.0735 0.1875)
+(0.0030 0.0735 0.1875)
+(0.0060 0.0735 0.1875)
+(-0.0060 -0.0735 0.1905)
+(-0.0030 -0.0735 0.1905)
+(0.0000 -0.0735 0.1905)
+(0.0030 -0.0735 0.1905)
+(0.0060 -0.0735 0.1905)
+(-0.0060 -0.0705 0.1905)
+(-0.0030 -0.0705 0.1905)
+(0.0000 -0.0705 0.1905)
+(0.0030 -0.0705 0.1905)
+(0.0060 -0.0705 0.1905)
+(-0.0060 -0.0675 0.1905)
+(-0.0030 -0.0675 0.1905)
+(0.0000 -0.0675 0.1905)
+(0.0030 -0.0675 0.1905)
+(0.0060 -0.0675 0.1905)
+(-0.0060 -0.0645 0.1905)
+(-0.0030 -0.0645 0.1905)
+(0.0000 -0.0645 0.1905)
+(0.0030 -0.0645 0.1905)
+(0.0060 -0.0645 0.1905)
+(-0.0060 -0.0615 0.1905)
+(-0.0030 -0.0615 0.1905)
+(0.0000 -0.0615 0.1905)
+(0.0030 -0.0615 0.1905)
+(0.0060 -0.0615 0.1905)
+(-0.0060 -0.0585 0.1905)
+(-0.0030 -0.0585 0.1905)
+(0.0000 -0.0585 0.1905)
+(0.0030 -0.0585 0.1905)
+(0.0060 -0.0585 0.1905)
+(-0.0060 -0.0555 0.1905)
+(-0.0030 -0.0555 0.1905)
+(0.0000 -0.0555 0.1905)
+(0.0030 -0.0555 0.1905)
+(0.0060 -0.0555 0.1905)
+(-0.0060 -0.0525 0.1905)
+(-0.0030 -0.0525 0.1905)
+(0.0000 -0.0525 0.1905)
+(0.0030 -0.0525 0.1905)
+(0.0060 -0.0525 0.1905)
+(-0.0060 -0.0495 0.1905)
+(-0.0030 -0.0495 0.1905)
+(0.0000 -0.0495 0.1905)
+(0.0030 -0.0495 0.1905)
+(0.0060 -0.0495 0.1905)
+(-0.0060 -0.0465 0.1905)
+(-0.0030 -0.0465 0.1905)
+(0.0000 -0.0465 0.1905)
+(0.0030 -0.0465 0.1905)
+(0.0060 -0.0465 0.1905)
+(-0.0060 -0.0435 0.1905)
+(-0.0030 -0.0435 0.1905)
+(0.0000 -0.0435 0.1905)
+(0.0030 -0.0435 0.1905)
+(0.0060 -0.0435 0.1905)
+(-0.0060 -0.0405 0.1905)
+(-0.0030 -0.0405 0.1905)
+(0.0000 -0.0405 0.1905)
+(0.0030 -0.0405 0.1905)
+(0.0060 -0.0405 0.1905)
+(-0.0060 -0.0375 0.1905)
+(-0.0030 -0.0375 0.1905)
+(0.0000 -0.0375 0.1905)
+(0.0030 -0.0375 0.1905)
+(0.0060 -0.0375 0.1905)
+(-0.0060 -0.0345 0.1905)
+(-0.0030 -0.0345 0.1905)
+(0.0000 -0.0345 0.1905)
+(0.0030 -0.0345 0.1905)
+(0.0060 -0.0345 0.1905)
+(-0.0060 -0.0315 0.1905)
+(-0.0030 -0.0315 0.1905)
+(0.0000 -0.0315 0.1905)
+(0.0030 -0.0315 0.1905)
+(0.0060 -0.0315 0.1905)
+(-0.0060 -0.0285 0.1905)
+(-0.0030 -0.0285 0.1905)
+(0.0000 -0.0285 0.1905)
+(0.0030 -0.0285 0.1905)
+(0.0060 -0.0285 0.1905)
+(-0.0060 -0.0255 0.1905)
+(-0.0030 -0.0255 0.1905)
+(0.0000 -0.0255 0.1905)
+(0.0030 -0.0255 0.1905)
+(0.0060 -0.0255 0.1905)
+(-0.0060 -0.0225 0.1905)
+(-0.0030 -0.0225 0.1905)
+(0.0000 -0.0225 0.1905)
+(0.0030 -0.0225 0.1905)
+(0.0060 -0.0225 0.1905)
+(-0.0060 -0.0195 0.1905)
+(-0.0030 -0.0195 0.1905)
+(0.0000 -0.0195 0.1905)
+(0.0030 -0.0195 0.1905)
+(0.0060 -0.0195 0.1905)
+(-0.0060 -0.0165 0.1905)
+(-0.0030 -0.0165 0.1905)
+(0.0000 -0.0165 0.1905)
+(0.0030 -0.0165 0.1905)
+(0.0060 -0.0165 0.1905)
+(-0.0060 -0.0135 0.1905)
+(-0.0030 -0.0135 0.1905)
+(0.0000 -0.0135 0.1905)
+(0.0030 -0.0135 0.1905)
+(0.0060 -0.0135 0.1905)
+(-0.0060 -0.0105 0.1905)
+(-0.0030 -0.0105 0.1905)
+(0.0000 -0.0105 0.1905)
+(0.0030 -0.0105 0.1905)
+(0.0060 -0.0105 0.1905)
+(-0.0060 -0.0075 0.1905)
+(-0.0030 -0.0075 0.1905)
+(0.0000 -0.0075 0.1905)
+(0.0030 -0.0075 0.1905)
+(0.0060 -0.0075 0.1905)
+(-0.0060 -0.0045 0.1905)
+(-0.0030 -0.0045 0.1905)
+(0.0000 -0.0045 0.1905)
+(0.0030 -0.0045 0.1905)
+(0.0060 -0.0045 0.1905)
+(-0.0060 -0.0015 0.1905)
+(-0.0030 -0.0015 0.1905)
+(0.0000 -0.0015 0.1905)
+(0.0030 -0.0015 0.1905)
+(0.0060 -0.0015 0.1905)
+(-0.0060 0.0015 0.1905)
+(-0.0030 0.0015 0.1905)
+(0.0000 0.0015 0.1905)
+(0.0030 0.0015 0.1905)
+(0.0060 0.0015 0.1905)
+(-0.0060 0.0045 0.1905)
+(-0.0030 0.0045 0.1905)
+(0.0000 0.0045 0.1905)
+(0.0030 0.0045 0.1905)
+(0.0060 0.0045 0.1905)
+(-0.0060 0.0075 0.1905)
+(-0.0030 0.0075 0.1905)
+(0.0000 0.0075 0.1905)
+(0.0030 0.0075 0.1905)
+(0.0060 0.0075 0.1905)
+(-0.0060 0.0105 0.1905)
+(-0.0030 0.0105 0.1905)
+(0.0000 0.0105 0.1905)
+(0.0030 0.0105 0.1905)
+(0.0060 0.0105 0.1905)
+(-0.0060 0.0135 0.1905)
+(-0.0030 0.0135 0.1905)
+(0.0000 0.0135 0.1905)
+(0.0030 0.0135 0.1905)
+(0.0060 0.0135 0.1905)
+(-0.0060 0.0165 0.1905)
+(-0.0030 0.0165 0.1905)
+(0.0000 0.0165 0.1905)
+(0.0030 0.0165 0.1905)
+(0.0060 0.0165 0.1905)
+(-0.0060 0.0195 0.1905)
+(-0.0030 0.0195 0.1905)
+(0.0000 0.0195 0.1905)
+(0.0030 0.0195 0.1905)
+(0.0060 0.0195 0.1905)
+(-0.0060 0.0225 0.1905)
+(-0.0030 0.0225 0.1905)
+(0.0000 0.0225 0.1905)
+(0.0030 0.0225 0.1905)
+(0.0060 0.0225 0.1905)
+(-0.0060 0.0255 0.1905)
+(-0.0030 0.0255 0.1905)
+(0.0000 0.0255 0.1905)
+(0.0030 0.0255 0.1905)
+(0.0060 0.0255 0.1905)
+(-0.0060 0.0285 0.1905)
+(-0.0030 0.0285 0.1905)
+(0.0000 0.0285 0.1905)
+(0.0030 0.0285 0.1905)
+(0.0060 0.0285 0.1905)
+(-0.0060 0.0315 0.1905)
+(-0.0030 0.0315 0.1905)
+(0.0000 0.0315 0.1905)
+(0.0030 0.0315 0.1905)
+(0.0060 0.0315 0.1905)
+(-0.0060 0.0345 0.1905)
+(-0.0030 0.0345 0.1905)
+(0.0000 0.0345 0.1905)
+(0.0030 0.0345 0.1905)
+(0.0060 0.0345 0.1905)
+(-0.0060 0.0375 0.1905)
+(-0.0030 0.0375 0.1905)
+(0.0000 0.0375 0.1905)
+(0.0030 0.0375 0.1905)
+(0.0060 0.0375 0.1905)
+(-0.0060 0.0405 0.1905)
+(-0.0030 0.0405 0.1905)
+(0.0000 0.0405 0.1905)
+(0.0030 0.0405 0.1905)
+(0.0060 0.0405 0.1905)
+(-0.0060 0.0435 0.1905)
+(-0.0030 0.0435 0.1905)
+(0.0000 0.0435 0.1905)
+(0.0030 0.0435 0.1905)
+(0.0060 0.0435 0.1905)
+(-0.0060 0.0465 0.1905)
+(-0.0030 0.0465 0.1905)
+(0.0000 0.0465 0.1905)
+(0.0030 0.0465 0.1905)
+(0.0060 0.0465 0.1905)
+(-0.0060 0.0495 0.1905)
+(-0.0030 0.0495 0.1905)
+(0.0000 0.0495 0.1905)
+(0.0030 0.0495 0.1905)
+(0.0060 0.0495 0.1905)
+(-0.0060 0.0525 0.1905)
+(-0.0030 0.0525 0.1905)
+(0.0000 0.0525 0.1905)
+(0.0030 0.0525 0.1905)
+(0.0060 0.0525 0.1905)
+(-0.0060 0.0555 0.1905)
+(-0.0030 0.0555 0.1905)
+(0.0000 0.0555 0.1905)
+(0.0030 0.0555 0.1905)
+(0.0060 0.0555 0.1905)
+(-0.0060 0.0585 0.1905)
+(-0.0030 0.0585 0.1905)
+(0.0000 0.0585 0.1905)
+(0.0030 0.0585 0.1905)
+(0.0060 0.0585 0.1905)
+(-0.0060 0.0615 0.1905)
+(-0.0030 0.0615 0.1905)
+(0.0000 0.0615 0.1905)
+(0.0030 0.0615 0.1905)
+(0.0060 0.0615 0.1905)
+(-0.0060 0.0645 0.1905)
+(-0.0030 0.0645 0.1905)
+(0.0000 0.0645 0.1905)
+(0.0030 0.0645 0.1905)
+(0.0060 0.0645 0.1905)
+(-0.0060 0.0675 0.1905)
+(-0.0030 0.0675 0.1905)
+(0.0000 0.0675 0.1905)
+(0.0030 0.0675 0.1905)
+(0.0060 0.0675 0.1905)
+(-0.0060 0.0705 0.1905)
+(-0.0030 0.0705 0.1905)
+(0.0000 0.0705 0.1905)
+(0.0030 0.0705 0.1905)
+(0.0060 0.0705 0.1905)
+(-0.0060 0.0735 0.1905)
+(-0.0030 0.0735 0.1905)
+(0.0000 0.0735 0.1905)
+(0.0030 0.0735 0.1905)
+(0.0060 0.0735 0.1905)
+(-0.0060 -0.0735 0.1935)
+(-0.0030 -0.0735 0.1935)
+(0.0000 -0.0735 0.1935)
+(0.0030 -0.0735 0.1935)
+(0.0060 -0.0735 0.1935)
+(-0.0060 -0.0705 0.1935)
+(-0.0030 -0.0705 0.1935)
+(0.0000 -0.0705 0.1935)
+(0.0030 -0.0705 0.1935)
+(0.0060 -0.0705 0.1935)
+(-0.0060 -0.0675 0.1935)
+(-0.0030 -0.0675 0.1935)
+(0.0000 -0.0675 0.1935)
+(0.0030 -0.0675 0.1935)
+(0.0060 -0.0675 0.1935)
+(-0.0060 -0.0645 0.1935)
+(-0.0030 -0.0645 0.1935)
+(0.0000 -0.0645 0.1935)
+(0.0030 -0.0645 0.1935)
+(0.0060 -0.0645 0.1935)
+(-0.0060 -0.0615 0.1935)
+(-0.0030 -0.0615 0.1935)
+(0.0000 -0.0615 0.1935)
+(0.0030 -0.0615 0.1935)
+(0.0060 -0.0615 0.1935)
+(-0.0060 -0.0585 0.1935)
+(-0.0030 -0.0585 0.1935)
+(0.0000 -0.0585 0.1935)
+(0.0030 -0.0585 0.1935)
+(0.0060 -0.0585 0.1935)
+(-0.0060 -0.0555 0.1935)
+(-0.0030 -0.0555 0.1935)
+(0.0000 -0.0555 0.1935)
+(0.0030 -0.0555 0.1935)
+(0.0060 -0.0555 0.1935)
+(-0.0060 -0.0525 0.1935)
+(-0.0030 -0.0525 0.1935)
+(0.0000 -0.0525 0.1935)
+(0.0030 -0.0525 0.1935)
+(0.0060 -0.0525 0.1935)
+(-0.0060 -0.0495 0.1935)
+(-0.0030 -0.0495 0.1935)
+(0.0000 -0.0495 0.1935)
+(0.0030 -0.0495 0.1935)
+(0.0060 -0.0495 0.1935)
+(-0.0060 -0.0465 0.1935)
+(-0.0030 -0.0465 0.1935)
+(0.0000 -0.0465 0.1935)
+(0.0030 -0.0465 0.1935)
+(0.0060 -0.0465 0.1935)
+(-0.0060 -0.0435 0.1935)
+(-0.0030 -0.0435 0.1935)
+(0.0000 -0.0435 0.1935)
+(0.0030 -0.0435 0.1935)
+(0.0060 -0.0435 0.1935)
+(-0.0060 -0.0405 0.1935)
+(-0.0030 -0.0405 0.1935)
+(0.0000 -0.0405 0.1935)
+(0.0030 -0.0405 0.1935)
+(0.0060 -0.0405 0.1935)
+(-0.0060 -0.0375 0.1935)
+(-0.0030 -0.0375 0.1935)
+(0.0000 -0.0375 0.1935)
+(0.0030 -0.0375 0.1935)
+(0.0060 -0.0375 0.1935)
+(-0.0060 -0.0345 0.1935)
+(-0.0030 -0.0345 0.1935)
+(0.0000 -0.0345 0.1935)
+(0.0030 -0.0345 0.1935)
+(0.0060 -0.0345 0.1935)
+(-0.0060 -0.0315 0.1935)
+(-0.0030 -0.0315 0.1935)
+(0.0000 -0.0315 0.1935)
+(0.0030 -0.0315 0.1935)
+(0.0060 -0.0315 0.1935)
+(-0.0060 -0.0285 0.1935)
+(-0.0030 -0.0285 0.1935)
+(0.0000 -0.0285 0.1935)
+(0.0030 -0.0285 0.1935)
+(0.0060 -0.0285 0.1935)
+(-0.0060 -0.0255 0.1935)
+(-0.0030 -0.0255 0.1935)
+(0.0000 -0.0255 0.1935)
+(0.0030 -0.0255 0.1935)
+(0.0060 -0.0255 0.1935)
+(-0.0060 -0.0225 0.1935)
+(-0.0030 -0.0225 0.1935)
+(0.0000 -0.0225 0.1935)
+(0.0030 -0.0225 0.1935)
+(0.0060 -0.0225 0.1935)
+(-0.0060 -0.0195 0.1935)
+(-0.0030 -0.0195 0.1935)
+(0.0000 -0.0195 0.1935)
+(0.0030 -0.0195 0.1935)
+(0.0060 -0.0195 0.1935)
+(-0.0060 -0.0165 0.1935)
+(-0.0030 -0.0165 0.1935)
+(0.0000 -0.0165 0.1935)
+(0.0030 -0.0165 0.1935)
+(0.0060 -0.0165 0.1935)
+(-0.0060 -0.0135 0.1935)
+(-0.0030 -0.0135 0.1935)
+(0.0000 -0.0135 0.1935)
+(0.0030 -0.0135 0.1935)
+(0.0060 -0.0135 0.1935)
+(-0.0060 -0.0105 0.1935)
+(-0.0030 -0.0105 0.1935)
+(0.0000 -0.0105 0.1935)
+(0.0030 -0.0105 0.1935)
+(0.0060 -0.0105 0.1935)
+(-0.0060 -0.0075 0.1935)
+(-0.0030 -0.0075 0.1935)
+(0.0000 -0.0075 0.1935)
+(0.0030 -0.0075 0.1935)
+(0.0060 -0.0075 0.1935)
+(-0.0060 -0.0045 0.1935)
+(-0.0030 -0.0045 0.1935)
+(0.0000 -0.0045 0.1935)
+(0.0030 -0.0045 0.1935)
+(0.0060 -0.0045 0.1935)
+(-0.0060 -0.0015 0.1935)
+(-0.0030 -0.0015 0.1935)
+(0.0000 -0.0015 0.1935)
+(0.0030 -0.0015 0.1935)
+(0.0060 -0.0015 0.1935)
+(-0.0060 0.0015 0.1935)
+(-0.0030 0.0015 0.1935)
+(0.0000 0.0015 0.1935)
+(0.0030 0.0015 0.1935)
+(0.0060 0.0015 0.1935)
+(-0.0060 0.0045 0.1935)
+(-0.0030 0.0045 0.1935)
+(0.0000 0.0045 0.1935)
+(0.0030 0.0045 0.1935)
+(0.0060 0.0045 0.1935)
+(-0.0060 0.0075 0.1935)
+(-0.0030 0.0075 0.1935)
+(0.0000 0.0075 0.1935)
+(0.0030 0.0075 0.1935)
+(0.0060 0.0075 0.1935)
+(-0.0060 0.0105 0.1935)
+(-0.0030 0.0105 0.1935)
+(0.0000 0.0105 0.1935)
+(0.0030 0.0105 0.1935)
+(0.0060 0.0105 0.1935)
+(-0.0060 0.0135 0.1935)
+(-0.0030 0.0135 0.1935)
+(0.0000 0.0135 0.1935)
+(0.0030 0.0135 0.1935)
+(0.0060 0.0135 0.1935)
+(-0.0060 0.0165 0.1935)
+(-0.0030 0.0165 0.1935)
+(0.0000 0.0165 0.1935)
+(0.0030 0.0165 0.1935)
+(0.0060 0.0165 0.1935)
+(-0.0060 0.0195 0.1935)
+(-0.0030 0.0195 0.1935)
+(0.0000 0.0195 0.1935)
+(0.0030 0.0195 0.1935)
+(0.0060 0.0195 0.1935)
+(-0.0060 0.0225 0.1935)
+(-0.0030 0.0225 0.1935)
+(0.0000 0.0225 0.1935)
+(0.0030 0.0225 0.1935)
+(0.0060 0.0225 0.1935)
+(-0.0060 0.0255 0.1935)
+(-0.0030 0.0255 0.1935)
+(0.0000 0.0255 0.1935)
+(0.0030 0.0255 0.1935)
+(0.0060 0.0255 0.1935)
+(-0.0060 0.0285 0.1935)
+(-0.0030 0.0285 0.1935)
+(0.0000 0.0285 0.1935)
+(0.0030 0.0285 0.1935)
+(0.0060 0.0285 0.1935)
+(-0.0060 0.0315 0.1935)
+(-0.0030 0.0315 0.1935)
+(0.0000 0.0315 0.1935)
+(0.0030 0.0315 0.1935)
+(0.0060 0.0315 0.1935)
+(-0.0060 0.0345 0.1935)
+(-0.0030 0.0345 0.1935)
+(0.0000 0.0345 0.1935)
+(0.0030 0.0345 0.1935)
+(0.0060 0.0345 0.1935)
+(-0.0060 0.0375 0.1935)
+(-0.0030 0.0375 0.1935)
+(0.0000 0.0375 0.1935)
+(0.0030 0.0375 0.1935)
+(0.0060 0.0375 0.1935)
+(-0.0060 0.0405 0.1935)
+(-0.0030 0.0405 0.1935)
+(0.0000 0.0405 0.1935)
+(0.0030 0.0405 0.1935)
+(0.0060 0.0405 0.1935)
+(-0.0060 0.0435 0.1935)
+(-0.0030 0.0435 0.1935)
+(0.0000 0.0435 0.1935)
+(0.0030 0.0435 0.1935)
+(0.0060 0.0435 0.1935)
+(-0.0060 0.0465 0.1935)
+(-0.0030 0.0465 0.1935)
+(0.0000 0.0465 0.1935)
+(0.0030 0.0465 0.1935)
+(0.0060 0.0465 0.1935)
+(-0.0060 0.0495 0.1935)
+(-0.0030 0.0495 0.1935)
+(0.0000 0.0495 0.1935)
+(0.0030 0.0495 0.1935)
+(0.0060 0.0495 0.1935)
+(-0.0060 0.0525 0.1935)
+(-0.0030 0.0525 0.1935)
+(0.0000 0.0525 0.1935)
+(0.0030 0.0525 0.1935)
+(0.0060 0.0525 0.1935)
+(-0.0060 0.0555 0.1935)
+(-0.0030 0.0555 0.1935)
+(0.0000 0.0555 0.1935)
+(0.0030 0.0555 0.1935)
+(0.0060 0.0555 0.1935)
+(-0.0060 0.0585 0.1935)
+(-0.0030 0.0585 0.1935)
+(0.0000 0.0585 0.1935)
+(0.0030 0.0585 0.1935)
+(0.0060 0.0585 0.1935)
+(-0.0060 0.0615 0.1935)
+(-0.0030 0.0615 0.1935)
+(0.0000 0.0615 0.1935)
+(0.0030 0.0615 0.1935)
+(0.0060 0.0615 0.1935)
+(-0.0060 0.0645 0.1935)
+(-0.0030 0.0645 0.1935)
+(0.0000 0.0645 0.1935)
+(0.0030 0.0645 0.1935)
+(0.0060 0.0645 0.1935)
+(-0.0060 0.0675 0.1935)
+(-0.0030 0.0675 0.1935)
+(0.0000 0.0675 0.1935)
+(0.0030 0.0675 0.1935)
+(0.0060 0.0675 0.1935)
+(-0.0060 0.0705 0.1935)
+(-0.0030 0.0705 0.1935)
+(0.0000 0.0705 0.1935)
+(0.0030 0.0705 0.1935)
+(0.0060 0.0705 0.1935)
+(-0.0060 0.0735 0.1935)
+(-0.0030 0.0735 0.1935)
+(0.0000 0.0735 0.1935)
+(0.0030 0.0735 0.1935)
+(0.0060 0.0735 0.1935)
+(-0.0060 -0.0735 0.1965)
+(-0.0030 -0.0735 0.1965)
+(0.0000 -0.0735 0.1965)
+(0.0030 -0.0735 0.1965)
+(0.0060 -0.0735 0.1965)
+(-0.0060 -0.0705 0.1965)
+(-0.0030 -0.0705 0.1965)
+(0.0000 -0.0705 0.1965)
+(0.0030 -0.0705 0.1965)
+(0.0060 -0.0705 0.1965)
+(-0.0060 -0.0675 0.1965)
+(-0.0030 -0.0675 0.1965)
+(0.0000 -0.0675 0.1965)
+(0.0030 -0.0675 0.1965)
+(0.0060 -0.0675 0.1965)
+(-0.0060 -0.0645 0.1965)
+(-0.0030 -0.0645 0.1965)
+(0.0000 -0.0645 0.1965)
+(0.0030 -0.0645 0.1965)
+(0.0060 -0.0645 0.1965)
+(-0.0060 -0.0615 0.1965)
+(-0.0030 -0.0615 0.1965)
+(0.0000 -0.0615 0.1965)
+(0.0030 -0.0615 0.1965)
+(0.0060 -0.0615 0.1965)
+(-0.0060 -0.0585 0.1965)
+(-0.0030 -0.0585 0.1965)
+(0.0000 -0.0585 0.1965)
+(0.0030 -0.0585 0.1965)
+(0.0060 -0.0585 0.1965)
+(-0.0060 -0.0555 0.1965)
+(-0.0030 -0.0555 0.1965)
+(0.0000 -0.0555 0.1965)
+(0.0030 -0.0555 0.1965)
+(0.0060 -0.0555 0.1965)
+(-0.0060 -0.0525 0.1965)
+(-0.0030 -0.0525 0.1965)
+(0.0000 -0.0525 0.1965)
+(0.0030 -0.0525 0.1965)
+(0.0060 -0.0525 0.1965)
+(-0.0060 -0.0495 0.1965)
+(-0.0030 -0.0495 0.1965)
+(0.0000 -0.0495 0.1965)
+(0.0030 -0.0495 0.1965)
+(0.0060 -0.0495 0.1965)
+(-0.0060 -0.0465 0.1965)
+(-0.0030 -0.0465 0.1965)
+(0.0000 -0.0465 0.1965)
+(0.0030 -0.0465 0.1965)
+(0.0060 -0.0465 0.1965)
+(-0.0060 -0.0435 0.1965)
+(-0.0030 -0.0435 0.1965)
+(0.0000 -0.0435 0.1965)
+(0.0030 -0.0435 0.1965)
+(0.0060 -0.0435 0.1965)
+(-0.0060 -0.0405 0.1965)
+(-0.0030 -0.0405 0.1965)
+(0.0000 -0.0405 0.1965)
+(0.0030 -0.0405 0.1965)
+(0.0060 -0.0405 0.1965)
+(-0.0060 -0.0375 0.1965)
+(-0.0030 -0.0375 0.1965)
+(0.0000 -0.0375 0.1965)
+(0.0030 -0.0375 0.1965)
+(0.0060 -0.0375 0.1965)
+(-0.0060 -0.0345 0.1965)
+(-0.0030 -0.0345 0.1965)
+(0.0000 -0.0345 0.1965)
+(0.0030 -0.0345 0.1965)
+(0.0060 -0.0345 0.1965)
+(-0.0060 -0.0315 0.1965)
+(-0.0030 -0.0315 0.1965)
+(0.0000 -0.0315 0.1965)
+(0.0030 -0.0315 0.1965)
+(0.0060 -0.0315 0.1965)
+(-0.0060 -0.0285 0.1965)
+(-0.0030 -0.0285 0.1965)
+(0.0000 -0.0285 0.1965)
+(0.0030 -0.0285 0.1965)
+(0.0060 -0.0285 0.1965)
+(-0.0060 -0.0255 0.1965)
+(-0.0030 -0.0255 0.1965)
+(0.0000 -0.0255 0.1965)
+(0.0030 -0.0255 0.1965)
+(0.0060 -0.0255 0.1965)
+(-0.0060 -0.0225 0.1965)
+(-0.0030 -0.0225 0.1965)
+(0.0000 -0.0225 0.1965)
+(0.0030 -0.0225 0.1965)
+(0.0060 -0.0225 0.1965)
+(-0.0060 -0.0195 0.1965)
+(-0.0030 -0.0195 0.1965)
+(0.0000 -0.0195 0.1965)
+(0.0030 -0.0195 0.1965)
+(0.0060 -0.0195 0.1965)
+(-0.0060 -0.0165 0.1965)
+(-0.0030 -0.0165 0.1965)
+(0.0000 -0.0165 0.1965)
+(0.0030 -0.0165 0.1965)
+(0.0060 -0.0165 0.1965)
+(-0.0060 -0.0135 0.1965)
+(-0.0030 -0.0135 0.1965)
+(0.0000 -0.0135 0.1965)
+(0.0030 -0.0135 0.1965)
+(0.0060 -0.0135 0.1965)
+(-0.0060 -0.0105 0.1965)
+(-0.0030 -0.0105 0.1965)
+(0.0000 -0.0105 0.1965)
+(0.0030 -0.0105 0.1965)
+(0.0060 -0.0105 0.1965)
+(-0.0060 -0.0075 0.1965)
+(-0.0030 -0.0075 0.1965)
+(0.0000 -0.0075 0.1965)
+(0.0030 -0.0075 0.1965)
+(0.0060 -0.0075 0.1965)
+(-0.0060 -0.0045 0.1965)
+(-0.0030 -0.0045 0.1965)
+(0.0000 -0.0045 0.1965)
+(0.0030 -0.0045 0.1965)
+(0.0060 -0.0045 0.1965)
+(-0.0060 -0.0015 0.1965)
+(-0.0030 -0.0015 0.1965)
+(0.0000 -0.0015 0.1965)
+(0.0030 -0.0015 0.1965)
+(0.0060 -0.0015 0.1965)
+(-0.0060 0.0015 0.1965)
+(-0.0030 0.0015 0.1965)
+(0.0000 0.0015 0.1965)
+(0.0030 0.0015 0.1965)
+(0.0060 0.0015 0.1965)
+(-0.0060 0.0045 0.1965)
+(-0.0030 0.0045 0.1965)
+(0.0000 0.0045 0.1965)
+(0.0030 0.0045 0.1965)
+(0.0060 0.0045 0.1965)
+(-0.0060 0.0075 0.1965)
+(-0.0030 0.0075 0.1965)
+(0.0000 0.0075 0.1965)
+(0.0030 0.0075 0.1965)
+(0.0060 0.0075 0.1965)
+(-0.0060 0.0105 0.1965)
+(-0.0030 0.0105 0.1965)
+(0.0000 0.0105 0.1965)
+(0.0030 0.0105 0.1965)
+(0.0060 0.0105 0.1965)
+(-0.0060 0.0135 0.1965)
+(-0.0030 0.0135 0.1965)
+(0.0000 0.0135 0.1965)
+(0.0030 0.0135 0.1965)
+(0.0060 0.0135 0.1965)
+(-0.0060 0.0165 0.1965)
+(-0.0030 0.0165 0.1965)
+(0.0000 0.0165 0.1965)
+(0.0030 0.0165 0.1965)
+(0.0060 0.0165 0.1965)
+(-0.0060 0.0195 0.1965)
+(-0.0030 0.0195 0.1965)
+(0.0000 0.0195 0.1965)
+(0.0030 0.0195 0.1965)
+(0.0060 0.0195 0.1965)
+(-0.0060 0.0225 0.1965)
+(-0.0030 0.0225 0.1965)
+(0.0000 0.0225 0.1965)
+(0.0030 0.0225 0.1965)
+(0.0060 0.0225 0.1965)
+(-0.0060 0.0255 0.1965)
+(-0.0030 0.0255 0.1965)
+(0.0000 0.0255 0.1965)
+(0.0030 0.0255 0.1965)
+(0.0060 0.0255 0.1965)
+(-0.0060 0.0285 0.1965)
+(-0.0030 0.0285 0.1965)
+(0.0000 0.0285 0.1965)
+(0.0030 0.0285 0.1965)
+(0.0060 0.0285 0.1965)
+(-0.0060 0.0315 0.1965)
+(-0.0030 0.0315 0.1965)
+(0.0000 0.0315 0.1965)
+(0.0030 0.0315 0.1965)
+(0.0060 0.0315 0.1965)
+(-0.0060 0.0345 0.1965)
+(-0.0030 0.0345 0.1965)
+(0.0000 0.0345 0.1965)
+(0.0030 0.0345 0.1965)
+(0.0060 0.0345 0.1965)
+(-0.0060 0.0375 0.1965)
+(-0.0030 0.0375 0.1965)
+(0.0000 0.0375 0.1965)
+(0.0030 0.0375 0.1965)
+(0.0060 0.0375 0.1965)
+(-0.0060 0.0405 0.1965)
+(-0.0030 0.0405 0.1965)
+(0.0000 0.0405 0.1965)
+(0.0030 0.0405 0.1965)
+(0.0060 0.0405 0.1965)
+(-0.0060 0.0435 0.1965)
+(-0.0030 0.0435 0.1965)
+(0.0000 0.0435 0.1965)
+(0.0030 0.0435 0.1965)
+(0.0060 0.0435 0.1965)
+(-0.0060 0.0465 0.1965)
+(-0.0030 0.0465 0.1965)
+(0.0000 0.0465 0.1965)
+(0.0030 0.0465 0.1965)
+(0.0060 0.0465 0.1965)
+(-0.0060 0.0495 0.1965)
+(-0.0030 0.0495 0.1965)
+(0.0000 0.0495 0.1965)
+(0.0030 0.0495 0.1965)
+(0.0060 0.0495 0.1965)
+(-0.0060 0.0525 0.1965)
+(-0.0030 0.0525 0.1965)
+(0.0000 0.0525 0.1965)
+(0.0030 0.0525 0.1965)
+(0.0060 0.0525 0.1965)
+(-0.0060 0.0555 0.1965)
+(-0.0030 0.0555 0.1965)
+(0.0000 0.0555 0.1965)
+(0.0030 0.0555 0.1965)
+(0.0060 0.0555 0.1965)
+(-0.0060 0.0585 0.1965)
+(-0.0030 0.0585 0.1965)
+(0.0000 0.0585 0.1965)
+(0.0030 0.0585 0.1965)
+(0.0060 0.0585 0.1965)
+(-0.0060 0.0615 0.1965)
+(-0.0030 0.0615 0.1965)
+(0.0000 0.0615 0.1965)
+(0.0030 0.0615 0.1965)
+(0.0060 0.0615 0.1965)
+(-0.0060 0.0645 0.1965)
+(-0.0030 0.0645 0.1965)
+(0.0000 0.0645 0.1965)
+(0.0030 0.0645 0.1965)
+(0.0060 0.0645 0.1965)
+(-0.0060 0.0675 0.1965)
+(-0.0030 0.0675 0.1965)
+(0.0000 0.0675 0.1965)
+(0.0030 0.0675 0.1965)
+(0.0060 0.0675 0.1965)
+(-0.0060 0.0705 0.1965)
+(-0.0030 0.0705 0.1965)
+(0.0000 0.0705 0.1965)
+(0.0030 0.0705 0.1965)
+(0.0060 0.0705 0.1965)
+(-0.0060 0.0735 0.1965)
+(-0.0030 0.0735 0.1965)
+(0.0000 0.0735 0.1965)
+(0.0030 0.0735 0.1965)
+(0.0060 0.0735 0.1965)
+(-0.0060 -0.0735 0.1995)
+(-0.0030 -0.0735 0.1995)
+(0.0000 -0.0735 0.1995)
+(0.0030 -0.0735 0.1995)
+(0.0060 -0.0735 0.1995)
+(-0.0060 -0.0705 0.1995)
+(-0.0030 -0.0705 0.1995)
+(0.0000 -0.0705 0.1995)
+(0.0030 -0.0705 0.1995)
+(0.0060 -0.0705 0.1995)
+(-0.0060 -0.0675 0.1995)
+(-0.0030 -0.0675 0.1995)
+(0.0000 -0.0675 0.1995)
+(0.0030 -0.0675 0.1995)
+(0.0060 -0.0675 0.1995)
+(-0.0060 -0.0645 0.1995)
+(-0.0030 -0.0645 0.1995)
+(0.0000 -0.0645 0.1995)
+(0.0030 -0.0645 0.1995)
+(0.0060 -0.0645 0.1995)
+(-0.0060 -0.0615 0.1995)
+(-0.0030 -0.0615 0.1995)
+(0.0000 -0.0615 0.1995)
+(0.0030 -0.0615 0.1995)
+(0.0060 -0.0615 0.1995)
+(-0.0060 -0.0585 0.1995)
+(-0.0030 -0.0585 0.1995)
+(0.0000 -0.0585 0.1995)
+(0.0030 -0.0585 0.1995)
+(0.0060 -0.0585 0.1995)
+(-0.0060 -0.0555 0.1995)
+(-0.0030 -0.0555 0.1995)
+(0.0000 -0.0555 0.1995)
+(0.0030 -0.0555 0.1995)
+(0.0060 -0.0555 0.1995)
+(-0.0060 -0.0525 0.1995)
+(-0.0030 -0.0525 0.1995)
+(0.0000 -0.0525 0.1995)
+(0.0030 -0.0525 0.1995)
+(0.0060 -0.0525 0.1995)
+(-0.0060 -0.0495 0.1995)
+(-0.0030 -0.0495 0.1995)
+(0.0000 -0.0495 0.1995)
+(0.0030 -0.0495 0.1995)
+(0.0060 -0.0495 0.1995)
+(-0.0060 -0.0465 0.1995)
+(-0.0030 -0.0465 0.1995)
+(0.0000 -0.0465 0.1995)
+(0.0030 -0.0465 0.1995)
+(0.0060 -0.0465 0.1995)
+(-0.0060 -0.0435 0.1995)
+(-0.0030 -0.0435 0.1995)
+(0.0000 -0.0435 0.1995)
+(0.0030 -0.0435 0.1995)
+(0.0060 -0.0435 0.1995)
+(-0.0060 -0.0405 0.1995)
+(-0.0030 -0.0405 0.1995)
+(0.0000 -0.0405 0.1995)
+(0.0030 -0.0405 0.1995)
+(0.0060 -0.0405 0.1995)
+(-0.0060 -0.0375 0.1995)
+(-0.0030 -0.0375 0.1995)
+(0.0000 -0.0375 0.1995)
+(0.0030 -0.0375 0.1995)
+(0.0060 -0.0375 0.1995)
+(-0.0060 -0.0345 0.1995)
+(-0.0030 -0.0345 0.1995)
+(0.0000 -0.0345 0.1995)
+(0.0030 -0.0345 0.1995)
+(0.0060 -0.0345 0.1995)
+(-0.0060 -0.0315 0.1995)
+(-0.0030 -0.0315 0.1995)
+(0.0000 -0.0315 0.1995)
+(0.0030 -0.0315 0.1995)
+(0.0060 -0.0315 0.1995)
+(-0.0060 -0.0285 0.1995)
+(-0.0030 -0.0285 0.1995)
+(0.0000 -0.0285 0.1995)
+(0.0030 -0.0285 0.1995)
+(0.0060 -0.0285 0.1995)
+(-0.0060 -0.0255 0.1995)
+(-0.0030 -0.0255 0.1995)
+(0.0000 -0.0255 0.1995)
+(0.0030 -0.0255 0.1995)
+(0.0060 -0.0255 0.1995)
+(-0.0060 -0.0225 0.1995)
+(-0.0030 -0.0225 0.1995)
+(0.0000 -0.0225 0.1995)
+(0.0030 -0.0225 0.1995)
+(0.0060 -0.0225 0.1995)
+(-0.0060 -0.0195 0.1995)
+(-0.0030 -0.0195 0.1995)
+(0.0000 -0.0195 0.1995)
+(0.0030 -0.0195 0.1995)
+(0.0060 -0.0195 0.1995)
+(-0.0060 -0.0165 0.1995)
+(-0.0030 -0.0165 0.1995)
+(0.0000 -0.0165 0.1995)
+(0.0030 -0.0165 0.1995)
+(0.0060 -0.0165 0.1995)
+(-0.0060 -0.0135 0.1995)
+(-0.0030 -0.0135 0.1995)
+(0.0000 -0.0135 0.1995)
+(0.0030 -0.0135 0.1995)
+(0.0060 -0.0135 0.1995)
+(-0.0060 -0.0105 0.1995)
+(-0.0030 -0.0105 0.1995)
+(0.0000 -0.0105 0.1995)
+(0.0030 -0.0105 0.1995)
+(0.0060 -0.0105 0.1995)
+(-0.0060 -0.0075 0.1995)
+(-0.0030 -0.0075 0.1995)
+(0.0000 -0.0075 0.1995)
+(0.0030 -0.0075 0.1995)
+(0.0060 -0.0075 0.1995)
+(-0.0060 -0.0045 0.1995)
+(-0.0030 -0.0045 0.1995)
+(0.0000 -0.0045 0.1995)
+(0.0030 -0.0045 0.1995)
+(0.0060 -0.0045 0.1995)
+(-0.0060 -0.0015 0.1995)
+(-0.0030 -0.0015 0.1995)
+(0.0000 -0.0015 0.1995)
+(0.0030 -0.0015 0.1995)
+(0.0060 -0.0015 0.1995)
+(-0.0060 0.0015 0.1995)
+(-0.0030 0.0015 0.1995)
+(0.0000 0.0015 0.1995)
+(0.0030 0.0015 0.1995)
+(0.0060 0.0015 0.1995)
+(-0.0060 0.0045 0.1995)
+(-0.0030 0.0045 0.1995)
+(0.0000 0.0045 0.1995)
+(0.0030 0.0045 0.1995)
+(0.0060 0.0045 0.1995)
+(-0.0060 0.0075 0.1995)
+(-0.0030 0.0075 0.1995)
+(0.0000 0.0075 0.1995)
+(0.0030 0.0075 0.1995)
+(0.0060 0.0075 0.1995)
+(-0.0060 0.0105 0.1995)
+(-0.0030 0.0105 0.1995)
+(0.0000 0.0105 0.1995)
+(0.0030 0.0105 0.1995)
+(0.0060 0.0105 0.1995)
+(-0.0060 0.0135 0.1995)
+(-0.0030 0.0135 0.1995)
+(0.0000 0.0135 0.1995)
+(0.0030 0.0135 0.1995)
+(0.0060 0.0135 0.1995)
+(-0.0060 0.0165 0.1995)
+(-0.0030 0.0165 0.1995)
+(0.0000 0.0165 0.1995)
+(0.0030 0.0165 0.1995)
+(0.0060 0.0165 0.1995)
+(-0.0060 0.0195 0.1995)
+(-0.0030 0.0195 0.1995)
+(0.0000 0.0195 0.1995)
+(0.0030 0.0195 0.1995)
+(0.0060 0.0195 0.1995)
+(-0.0060 0.0225 0.1995)
+(-0.0030 0.0225 0.1995)
+(0.0000 0.0225 0.1995)
+(0.0030 0.0225 0.1995)
+(0.0060 0.0225 0.1995)
+(-0.0060 0.0255 0.1995)
+(-0.0030 0.0255 0.1995)
+(0.0000 0.0255 0.1995)
+(0.0030 0.0255 0.1995)
+(0.0060 0.0255 0.1995)
+(-0.0060 0.0285 0.1995)
+(-0.0030 0.0285 0.1995)
+(0.0000 0.0285 0.1995)
+(0.0030 0.0285 0.1995)
+(0.0060 0.0285 0.1995)
+(-0.0060 0.0315 0.1995)
+(-0.0030 0.0315 0.1995)
+(0.0000 0.0315 0.1995)
+(0.0030 0.0315 0.1995)
+(0.0060 0.0315 0.1995)
+(-0.0060 0.0345 0.1995)
+(-0.0030 0.0345 0.1995)
+(0.0000 0.0345 0.1995)
+(0.0030 0.0345 0.1995)
+(0.0060 0.0345 0.1995)
+(-0.0060 0.0375 0.1995)
+(-0.0030 0.0375 0.1995)
+(0.0000 0.0375 0.1995)
+(0.0030 0.0375 0.1995)
+(0.0060 0.0375 0.1995)
+(-0.0060 0.0405 0.1995)
+(-0.0030 0.0405 0.1995)
+(0.0000 0.0405 0.1995)
+(0.0030 0.0405 0.1995)
+(0.0060 0.0405 0.1995)
+(-0.0060 0.0435 0.1995)
+(-0.0030 0.0435 0.1995)
+(0.0000 0.0435 0.1995)
+(0.0030 0.0435 0.1995)
+(0.0060 0.0435 0.1995)
+(-0.0060 0.0465 0.1995)
+(-0.0030 0.0465 0.1995)
+(0.0000 0.0465 0.1995)
+(0.0030 0.0465 0.1995)
+(0.0060 0.0465 0.1995)
+(-0.0060 0.0495 0.1995)
+(-0.0030 0.0495 0.1995)
+(0.0000 0.0495 0.1995)
+(0.0030 0.0495 0.1995)
+(0.0060 0.0495 0.1995)
+(-0.0060 0.0525 0.1995)
+(-0.0030 0.0525 0.1995)
+(0.0000 0.0525 0.1995)
+(0.0030 0.0525 0.1995)
+(0.0060 0.0525 0.1995)
+(-0.0060 0.0555 0.1995)
+(-0.0030 0.0555 0.1995)
+(0.0000 0.0555 0.1995)
+(0.0030 0.0555 0.1995)
+(0.0060 0.0555 0.1995)
+(-0.0060 0.0585 0.1995)
+(-0.0030 0.0585 0.1995)
+(0.0000 0.0585 0.1995)
+(0.0030 0.0585 0.1995)
+(0.0060 0.0585 0.1995)
+(-0.0060 0.0615 0.1995)
+(-0.0030 0.0615 0.1995)
+(0.0000 0.0615 0.1995)
+(0.0030 0.0615 0.1995)
+(0.0060 0.0615 0.1995)
+(-0.0060 0.0645 0.1995)
+(-0.0030 0.0645 0.1995)
+(0.0000 0.0645 0.1995)
+(0.0030 0.0645 0.1995)
+(0.0060 0.0645 0.1995)
+(-0.0060 0.0675 0.1995)
+(-0.0030 0.0675 0.1995)
+(0.0000 0.0675 0.1995)
+(0.0030 0.0675 0.1995)
+(0.0060 0.0675 0.1995)
+(-0.0060 0.0705 0.1995)
+(-0.0030 0.0705 0.1995)
+(0.0000 0.0705 0.1995)
+(0.0030 0.0705 0.1995)
+(0.0060 0.0705 0.1995)
+(-0.0060 0.0735 0.1995)
+(-0.0030 0.0735 0.1995)
+(0.0000 0.0735 0.1995)
+(0.0030 0.0735 0.1995)
+(0.0060 0.0735 0.1995)
+(-0.0060 -0.0735 0.2025)
+(-0.0030 -0.0735 0.2025)
+(0.0000 -0.0735 0.2025)
+(0.0030 -0.0735 0.2025)
+(0.0060 -0.0735 0.2025)
+(-0.0060 -0.0705 0.2025)
+(-0.0030 -0.0705 0.2025)
+(0.0000 -0.0705 0.2025)
+(0.0030 -0.0705 0.2025)
+(0.0060 -0.0705 0.2025)
+(-0.0060 -0.0675 0.2025)
+(-0.0030 -0.0675 0.2025)
+(0.0000 -0.0675 0.2025)
+(0.0030 -0.0675 0.2025)
+(0.0060 -0.0675 0.2025)
+(-0.0060 -0.0645 0.2025)
+(-0.0030 -0.0645 0.2025)
+(0.0000 -0.0645 0.2025)
+(0.0030 -0.0645 0.2025)
+(0.0060 -0.0645 0.2025)
+(-0.0060 -0.0615 0.2025)
+(-0.0030 -0.0615 0.2025)
+(0.0000 -0.0615 0.2025)
+(0.0030 -0.0615 0.2025)
+(0.0060 -0.0615 0.2025)
+(-0.0060 -0.0585 0.2025)
+(-0.0030 -0.0585 0.2025)
+(0.0000 -0.0585 0.2025)
+(0.0030 -0.0585 0.2025)
+(0.0060 -0.0585 0.2025)
+(-0.0060 -0.0555 0.2025)
+(-0.0030 -0.0555 0.2025)
+(0.0000 -0.0555 0.2025)
+(0.0030 -0.0555 0.2025)
+(0.0060 -0.0555 0.2025)
+(-0.0060 -0.0525 0.2025)
+(-0.0030 -0.0525 0.2025)
+(0.0000 -0.0525 0.2025)
+(0.0030 -0.0525 0.2025)
+(0.0060 -0.0525 0.2025)
+(-0.0060 -0.0495 0.2025)
+(-0.0030 -0.0495 0.2025)
+(0.0000 -0.0495 0.2025)
+(0.0030 -0.0495 0.2025)
+(0.0060 -0.0495 0.2025)
+(-0.0060 -0.0465 0.2025)
+(-0.0030 -0.0465 0.2025)
+(0.0000 -0.0465 0.2025)
+(0.0030 -0.0465 0.2025)
+(0.0060 -0.0465 0.2025)
+(-0.0060 -0.0435 0.2025)
+(-0.0030 -0.0435 0.2025)
+(0.0000 -0.0435 0.2025)
+(0.0030 -0.0435 0.2025)
+(0.0060 -0.0435 0.2025)
+(-0.0060 -0.0405 0.2025)
+(-0.0030 -0.0405 0.2025)
+(0.0000 -0.0405 0.2025)
+(0.0030 -0.0405 0.2025)
+(0.0060 -0.0405 0.2025)
+(-0.0060 -0.0375 0.2025)
+(-0.0030 -0.0375 0.2025)
+(0.0000 -0.0375 0.2025)
+(0.0030 -0.0375 0.2025)
+(0.0060 -0.0375 0.2025)
+(-0.0060 -0.0345 0.2025)
+(-0.0030 -0.0345 0.2025)
+(0.0000 -0.0345 0.2025)
+(0.0030 -0.0345 0.2025)
+(0.0060 -0.0345 0.2025)
+(-0.0060 -0.0315 0.2025)
+(-0.0030 -0.0315 0.2025)
+(0.0000 -0.0315 0.2025)
+(0.0030 -0.0315 0.2025)
+(0.0060 -0.0315 0.2025)
+(-0.0060 -0.0285 0.2025)
+(-0.0030 -0.0285 0.2025)
+(0.0000 -0.0285 0.2025)
+(0.0030 -0.0285 0.2025)
+(0.0060 -0.0285 0.2025)
+(-0.0060 -0.0255 0.2025)
+(-0.0030 -0.0255 0.2025)
+(0.0000 -0.0255 0.2025)
+(0.0030 -0.0255 0.2025)
+(0.0060 -0.0255 0.2025)
+(-0.0060 -0.0225 0.2025)
+(-0.0030 -0.0225 0.2025)
+(0.0000 -0.0225 0.2025)
+(0.0030 -0.0225 0.2025)
+(0.0060 -0.0225 0.2025)
+(-0.0060 -0.0195 0.2025)
+(-0.0030 -0.0195 0.2025)
+(0.0000 -0.0195 0.2025)
+(0.0030 -0.0195 0.2025)
+(0.0060 -0.0195 0.2025)
+(-0.0060 -0.0165 0.2025)
+(-0.0030 -0.0165 0.2025)
+(0.0000 -0.0165 0.2025)
+(0.0030 -0.0165 0.2025)
+(0.0060 -0.0165 0.2025)
+(-0.0060 -0.0135 0.2025)
+(-0.0030 -0.0135 0.2025)
+(0.0000 -0.0135 0.2025)
+(0.0030 -0.0135 0.2025)
+(0.0060 -0.0135 0.2025)
+(-0.0060 -0.0105 0.2025)
+(-0.0030 -0.0105 0.2025)
+(0.0000 -0.0105 0.2025)
+(0.0030 -0.0105 0.2025)
+(0.0060 -0.0105 0.2025)
+(-0.0060 -0.0075 0.2025)
+(-0.0030 -0.0075 0.2025)
+(0.0000 -0.0075 0.2025)
+(0.0030 -0.0075 0.2025)
+(0.0060 -0.0075 0.2025)
+(-0.0060 -0.0045 0.2025)
+(-0.0030 -0.0045 0.2025)
+(0.0000 -0.0045 0.2025)
+(0.0030 -0.0045 0.2025)
+(0.0060 -0.0045 0.2025)
+(-0.0060 -0.0015 0.2025)
+(-0.0030 -0.0015 0.2025)
+(0.0000 -0.0015 0.2025)
+(0.0030 -0.0015 0.2025)
+(0.0060 -0.0015 0.2025)
+(-0.0060 0.0015 0.2025)
+(-0.0030 0.0015 0.2025)
+(0.0000 0.0015 0.2025)
+(0.0030 0.0015 0.2025)
+(0.0060 0.0015 0.2025)
+(-0.0060 0.0045 0.2025)
+(-0.0030 0.0045 0.2025)
+(0.0000 0.0045 0.2025)
+(0.0030 0.0045 0.2025)
+(0.0060 0.0045 0.2025)
+(-0.0060 0.0075 0.2025)
+(-0.0030 0.0075 0.2025)
+(0.0000 0.0075 0.2025)
+(0.0030 0.0075 0.2025)
+(0.0060 0.0075 0.2025)
+(-0.0060 0.0105 0.2025)
+(-0.0030 0.0105 0.2025)
+(0.0000 0.0105 0.2025)
+(0.0030 0.0105 0.2025)
+(0.0060 0.0105 0.2025)
+(-0.0060 0.0135 0.2025)
+(-0.0030 0.0135 0.2025)
+(0.0000 0.0135 0.2025)
+(0.0030 0.0135 0.2025)
+(0.0060 0.0135 0.2025)
+(-0.0060 0.0165 0.2025)
+(-0.0030 0.0165 0.2025)
+(0.0000 0.0165 0.2025)
+(0.0030 0.0165 0.2025)
+(0.0060 0.0165 0.2025)
+(-0.0060 0.0195 0.2025)
+(-0.0030 0.0195 0.2025)
+(0.0000 0.0195 0.2025)
+(0.0030 0.0195 0.2025)
+(0.0060 0.0195 0.2025)
+(-0.0060 0.0225 0.2025)
+(-0.0030 0.0225 0.2025)
+(0.0000 0.0225 0.2025)
+(0.0030 0.0225 0.2025)
+(0.0060 0.0225 0.2025)
+(-0.0060 0.0255 0.2025)
+(-0.0030 0.0255 0.2025)
+(0.0000 0.0255 0.2025)
+(0.0030 0.0255 0.2025)
+(0.0060 0.0255 0.2025)
+(-0.0060 0.0285 0.2025)
+(-0.0030 0.0285 0.2025)
+(0.0000 0.0285 0.2025)
+(0.0030 0.0285 0.2025)
+(0.0060 0.0285 0.2025)
+(-0.0060 0.0315 0.2025)
+(-0.0030 0.0315 0.2025)
+(0.0000 0.0315 0.2025)
+(0.0030 0.0315 0.2025)
+(0.0060 0.0315 0.2025)
+(-0.0060 0.0345 0.2025)
+(-0.0030 0.0345 0.2025)
+(0.0000 0.0345 0.2025)
+(0.0030 0.0345 0.2025)
+(0.0060 0.0345 0.2025)
+(-0.0060 0.0375 0.2025)
+(-0.0030 0.0375 0.2025)
+(0.0000 0.0375 0.2025)
+(0.0030 0.0375 0.2025)
+(0.0060 0.0375 0.2025)
+(-0.0060 0.0405 0.2025)
+(-0.0030 0.0405 0.2025)
+(0.0000 0.0405 0.2025)
+(0.0030 0.0405 0.2025)
+(0.0060 0.0405 0.2025)
+(-0.0060 0.0435 0.2025)
+(-0.0030 0.0435 0.2025)
+(0.0000 0.0435 0.2025)
+(0.0030 0.0435 0.2025)
+(0.0060 0.0435 0.2025)
+(-0.0060 0.0465 0.2025)
+(-0.0030 0.0465 0.2025)
+(0.0000 0.0465 0.2025)
+(0.0030 0.0465 0.2025)
+(0.0060 0.0465 0.2025)
+(-0.0060 0.0495 0.2025)
+(-0.0030 0.0495 0.2025)
+(0.0000 0.0495 0.2025)
+(0.0030 0.0495 0.2025)
+(0.0060 0.0495 0.2025)
+(-0.0060 0.0525 0.2025)
+(-0.0030 0.0525 0.2025)
+(0.0000 0.0525 0.2025)
+(0.0030 0.0525 0.2025)
+(0.0060 0.0525 0.2025)
+(-0.0060 0.0555 0.2025)
+(-0.0030 0.0555 0.2025)
+(0.0000 0.0555 0.2025)
+(0.0030 0.0555 0.2025)
+(0.0060 0.0555 0.2025)
+(-0.0060 0.0585 0.2025)
+(-0.0030 0.0585 0.2025)
+(0.0000 0.0585 0.2025)
+(0.0030 0.0585 0.2025)
+(0.0060 0.0585 0.2025)
+(-0.0060 0.0615 0.2025)
+(-0.0030 0.0615 0.2025)
+(0.0000 0.0615 0.2025)
+(0.0030 0.0615 0.2025)
+(0.0060 0.0615 0.2025)
+(-0.0060 0.0645 0.2025)
+(-0.0030 0.0645 0.2025)
+(0.0000 0.0645 0.2025)
+(0.0030 0.0645 0.2025)
+(0.0060 0.0645 0.2025)
+(-0.0060 0.0675 0.2025)
+(-0.0030 0.0675 0.2025)
+(0.0000 0.0675 0.2025)
+(0.0030 0.0675 0.2025)
+(0.0060 0.0675 0.2025)
+(-0.0060 0.0705 0.2025)
+(-0.0030 0.0705 0.2025)
+(0.0000 0.0705 0.2025)
+(0.0030 0.0705 0.2025)
+(0.0060 0.0705 0.2025)
+(-0.0060 0.0735 0.2025)
+(-0.0030 0.0735 0.2025)
+(0.0000 0.0735 0.2025)
+(0.0030 0.0735 0.2025)
+(0.0060 0.0735 0.2025)
+(-0.0060 -0.0735 0.2055)
+(-0.0030 -0.0735 0.2055)
+(0.0000 -0.0735 0.2055)
+(0.0030 -0.0735 0.2055)
+(0.0060 -0.0735 0.2055)
+(-0.0060 -0.0705 0.2055)
+(-0.0030 -0.0705 0.2055)
+(0.0000 -0.0705 0.2055)
+(0.0030 -0.0705 0.2055)
+(0.0060 -0.0705 0.2055)
+(-0.0060 -0.0675 0.2055)
+(-0.0030 -0.0675 0.2055)
+(0.0000 -0.0675 0.2055)
+(0.0030 -0.0675 0.2055)
+(0.0060 -0.0675 0.2055)
+(-0.0060 -0.0645 0.2055)
+(-0.0030 -0.0645 0.2055)
+(0.0000 -0.0645 0.2055)
+(0.0030 -0.0645 0.2055)
+(0.0060 -0.0645 0.2055)
+(-0.0060 -0.0615 0.2055)
+(-0.0030 -0.0615 0.2055)
+(0.0000 -0.0615 0.2055)
+(0.0030 -0.0615 0.2055)
+(0.0060 -0.0615 0.2055)
+(-0.0060 -0.0585 0.2055)
+(-0.0030 -0.0585 0.2055)
+(0.0000 -0.0585 0.2055)
+(0.0030 -0.0585 0.2055)
+(0.0060 -0.0585 0.2055)
+(-0.0060 -0.0555 0.2055)
+(-0.0030 -0.0555 0.2055)
+(0.0000 -0.0555 0.2055)
+(0.0030 -0.0555 0.2055)
+(0.0060 -0.0555 0.2055)
+(-0.0060 -0.0525 0.2055)
+(-0.0030 -0.0525 0.2055)
+(0.0000 -0.0525 0.2055)
+(0.0030 -0.0525 0.2055)
+(0.0060 -0.0525 0.2055)
+(-0.0060 -0.0495 0.2055)
+(-0.0030 -0.0495 0.2055)
+(0.0000 -0.0495 0.2055)
+(0.0030 -0.0495 0.2055)
+(0.0060 -0.0495 0.2055)
+(-0.0060 -0.0465 0.2055)
+(-0.0030 -0.0465 0.2055)
+(0.0000 -0.0465 0.2055)
+(0.0030 -0.0465 0.2055)
+(0.0060 -0.0465 0.2055)
+(-0.0060 -0.0435 0.2055)
+(-0.0030 -0.0435 0.2055)
+(0.0000 -0.0435 0.2055)
+(0.0030 -0.0435 0.2055)
+(0.0060 -0.0435 0.2055)
+(-0.0060 -0.0405 0.2055)
+(-0.0030 -0.0405 0.2055)
+(0.0000 -0.0405 0.2055)
+(0.0030 -0.0405 0.2055)
+(0.0060 -0.0405 0.2055)
+(-0.0060 -0.0375 0.2055)
+(-0.0030 -0.0375 0.2055)
+(0.0000 -0.0375 0.2055)
+(0.0030 -0.0375 0.2055)
+(0.0060 -0.0375 0.2055)
+(-0.0060 -0.0345 0.2055)
+(-0.0030 -0.0345 0.2055)
+(0.0000 -0.0345 0.2055)
+(0.0030 -0.0345 0.2055)
+(0.0060 -0.0345 0.2055)
+(-0.0060 -0.0315 0.2055)
+(-0.0030 -0.0315 0.2055)
+(0.0000 -0.0315 0.2055)
+(0.0030 -0.0315 0.2055)
+(0.0060 -0.0315 0.2055)
+(-0.0060 -0.0285 0.2055)
+(-0.0030 -0.0285 0.2055)
+(0.0000 -0.0285 0.2055)
+(0.0030 -0.0285 0.2055)
+(0.0060 -0.0285 0.2055)
+(-0.0060 -0.0255 0.2055)
+(-0.0030 -0.0255 0.2055)
+(0.0000 -0.0255 0.2055)
+(0.0030 -0.0255 0.2055)
+(0.0060 -0.0255 0.2055)
+(-0.0060 -0.0225 0.2055)
+(-0.0030 -0.0225 0.2055)
+(0.0000 -0.0225 0.2055)
+(0.0030 -0.0225 0.2055)
+(0.0060 -0.0225 0.2055)
+(-0.0060 -0.0195 0.2055)
+(-0.0030 -0.0195 0.2055)
+(0.0000 -0.0195 0.2055)
+(0.0030 -0.0195 0.2055)
+(0.0060 -0.0195 0.2055)
+(-0.0060 -0.0165 0.2055)
+(-0.0030 -0.0165 0.2055)
+(0.0000 -0.0165 0.2055)
+(0.0030 -0.0165 0.2055)
+(0.0060 -0.0165 0.2055)
+(-0.0060 -0.0135 0.2055)
+(-0.0030 -0.0135 0.2055)
+(0.0000 -0.0135 0.2055)
+(0.0030 -0.0135 0.2055)
+(0.0060 -0.0135 0.2055)
+(-0.0060 -0.0105 0.2055)
+(-0.0030 -0.0105 0.2055)
+(0.0000 -0.0105 0.2055)
+(0.0030 -0.0105 0.2055)
+(0.0060 -0.0105 0.2055)
+(-0.0060 -0.0075 0.2055)
+(-0.0030 -0.0075 0.2055)
+(0.0000 -0.0075 0.2055)
+(0.0030 -0.0075 0.2055)
+(0.0060 -0.0075 0.2055)
+(-0.0060 -0.0045 0.2055)
+(-0.0030 -0.0045 0.2055)
+(0.0000 -0.0045 0.2055)
+(0.0030 -0.0045 0.2055)
+(0.0060 -0.0045 0.2055)
+(-0.0060 -0.0015 0.2055)
+(-0.0030 -0.0015 0.2055)
+(0.0000 -0.0015 0.2055)
+(0.0030 -0.0015 0.2055)
+(0.0060 -0.0015 0.2055)
+(-0.0060 0.0015 0.2055)
+(-0.0030 0.0015 0.2055)
+(0.0000 0.0015 0.2055)
+(0.0030 0.0015 0.2055)
+(0.0060 0.0015 0.2055)
+(-0.0060 0.0045 0.2055)
+(-0.0030 0.0045 0.2055)
+(0.0000 0.0045 0.2055)
+(0.0030 0.0045 0.2055)
+(0.0060 0.0045 0.2055)
+(-0.0060 0.0075 0.2055)
+(-0.0030 0.0075 0.2055)
+(0.0000 0.0075 0.2055)
+(0.0030 0.0075 0.2055)
+(0.0060 0.0075 0.2055)
+(-0.0060 0.0105 0.2055)
+(-0.0030 0.0105 0.2055)
+(0.0000 0.0105 0.2055)
+(0.0030 0.0105 0.2055)
+(0.0060 0.0105 0.2055)
+(-0.0060 0.0135 0.2055)
+(-0.0030 0.0135 0.2055)
+(0.0000 0.0135 0.2055)
+(0.0030 0.0135 0.2055)
+(0.0060 0.0135 0.2055)
+(-0.0060 0.0165 0.2055)
+(-0.0030 0.0165 0.2055)
+(0.0000 0.0165 0.2055)
+(0.0030 0.0165 0.2055)
+(0.0060 0.0165 0.2055)
+(-0.0060 0.0195 0.2055)
+(-0.0030 0.0195 0.2055)
+(0.0000 0.0195 0.2055)
+(0.0030 0.0195 0.2055)
+(0.0060 0.0195 0.2055)
+(-0.0060 0.0225 0.2055)
+(-0.0030 0.0225 0.2055)
+(0.0000 0.0225 0.2055)
+(0.0030 0.0225 0.2055)
+(0.0060 0.0225 0.2055)
+(-0.0060 0.0255 0.2055)
+(-0.0030 0.0255 0.2055)
+(0.0000 0.0255 0.2055)
+(0.0030 0.0255 0.2055)
+(0.0060 0.0255 0.2055)
+(-0.0060 0.0285 0.2055)
+(-0.0030 0.0285 0.2055)
+(0.0000 0.0285 0.2055)
+(0.0030 0.0285 0.2055)
+(0.0060 0.0285 0.2055)
+(-0.0060 0.0315 0.2055)
+(-0.0030 0.0315 0.2055)
+(0.0000 0.0315 0.2055)
+(0.0030 0.0315 0.2055)
+(0.0060 0.0315 0.2055)
+(-0.0060 0.0345 0.2055)
+(-0.0030 0.0345 0.2055)
+(0.0000 0.0345 0.2055)
+(0.0030 0.0345 0.2055)
+(0.0060 0.0345 0.2055)
+(-0.0060 0.0375 0.2055)
+(-0.0030 0.0375 0.2055)
+(0.0000 0.0375 0.2055)
+(0.0030 0.0375 0.2055)
+(0.0060 0.0375 0.2055)
+(-0.0060 0.0405 0.2055)
+(-0.0030 0.0405 0.2055)
+(0.0000 0.0405 0.2055)
+(0.0030 0.0405 0.2055)
+(0.0060 0.0405 0.2055)
+(-0.0060 0.0435 0.2055)
+(-0.0030 0.0435 0.2055)
+(0.0000 0.0435 0.2055)
+(0.0030 0.0435 0.2055)
+(0.0060 0.0435 0.2055)
+(-0.0060 0.0465 0.2055)
+(-0.0030 0.0465 0.2055)
+(0.0000 0.0465 0.2055)
+(0.0030 0.0465 0.2055)
+(0.0060 0.0465 0.2055)
+(-0.0060 0.0495 0.2055)
+(-0.0030 0.0495 0.2055)
+(0.0000 0.0495 0.2055)
+(0.0030 0.0495 0.2055)
+(0.0060 0.0495 0.2055)
+(-0.0060 0.0525 0.2055)
+(-0.0030 0.0525 0.2055)
+(0.0000 0.0525 0.2055)
+(0.0030 0.0525 0.2055)
+(0.0060 0.0525 0.2055)
+(-0.0060 0.0555 0.2055)
+(-0.0030 0.0555 0.2055)
+(0.0000 0.0555 0.2055)
+(0.0030 0.0555 0.2055)
+(0.0060 0.0555 0.2055)
+(-0.0060 0.0585 0.2055)
+(-0.0030 0.0585 0.2055)
+(0.0000 0.0585 0.2055)
+(0.0030 0.0585 0.2055)
+(0.0060 0.0585 0.2055)
+(-0.0060 0.0615 0.2055)
+(-0.0030 0.0615 0.2055)
+(0.0000 0.0615 0.2055)
+(0.0030 0.0615 0.2055)
+(0.0060 0.0615 0.2055)
+(-0.0060 0.0645 0.2055)
+(-0.0030 0.0645 0.2055)
+(0.0000 0.0645 0.2055)
+(0.0030 0.0645 0.2055)
+(0.0060 0.0645 0.2055)
+(-0.0060 0.0675 0.2055)
+(-0.0030 0.0675 0.2055)
+(0.0000 0.0675 0.2055)
+(0.0030 0.0675 0.2055)
+(0.0060 0.0675 0.2055)
+(-0.0060 0.0705 0.2055)
+(-0.0030 0.0705 0.2055)
+(0.0000 0.0705 0.2055)
+(0.0030 0.0705 0.2055)
+(0.0060 0.0705 0.2055)
+(-0.0060 0.0735 0.2055)
+(-0.0030 0.0735 0.2055)
+(0.0000 0.0735 0.2055)
+(0.0030 0.0735 0.2055)
+(0.0060 0.0735 0.2055)
+(-0.0060 -0.0735 0.2085)
+(-0.0030 -0.0735 0.2085)
+(0.0000 -0.0735 0.2085)
+(0.0030 -0.0735 0.2085)
+(0.0060 -0.0735 0.2085)
+(-0.0060 -0.0705 0.2085)
+(-0.0030 -0.0705 0.2085)
+(0.0000 -0.0705 0.2085)
+(0.0030 -0.0705 0.2085)
+(0.0060 -0.0705 0.2085)
+(-0.0060 -0.0675 0.2085)
+(-0.0030 -0.0675 0.2085)
+(0.0000 -0.0675 0.2085)
+(0.0030 -0.0675 0.2085)
+(0.0060 -0.0675 0.2085)
+(-0.0060 -0.0645 0.2085)
+(-0.0030 -0.0645 0.2085)
+(0.0000 -0.0645 0.2085)
+(0.0030 -0.0645 0.2085)
+(0.0060 -0.0645 0.2085)
+(-0.0060 -0.0615 0.2085)
+(-0.0030 -0.0615 0.2085)
+(0.0000 -0.0615 0.2085)
+(0.0030 -0.0615 0.2085)
+(0.0060 -0.0615 0.2085)
+(-0.0060 -0.0585 0.2085)
+(-0.0030 -0.0585 0.2085)
+(0.0000 -0.0585 0.2085)
+(0.0030 -0.0585 0.2085)
+(0.0060 -0.0585 0.2085)
+(-0.0060 -0.0555 0.2085)
+(-0.0030 -0.0555 0.2085)
+(0.0000 -0.0555 0.2085)
+(0.0030 -0.0555 0.2085)
+(0.0060 -0.0555 0.2085)
+(-0.0060 -0.0525 0.2085)
+(-0.0030 -0.0525 0.2085)
+(0.0000 -0.0525 0.2085)
+(0.0030 -0.0525 0.2085)
+(0.0060 -0.0525 0.2085)
+(-0.0060 -0.0495 0.2085)
+(-0.0030 -0.0495 0.2085)
+(0.0000 -0.0495 0.2085)
+(0.0030 -0.0495 0.2085)
+(0.0060 -0.0495 0.2085)
+(-0.0060 -0.0465 0.2085)
+(-0.0030 -0.0465 0.2085)
+(0.0000 -0.0465 0.2085)
+(0.0030 -0.0465 0.2085)
+(0.0060 -0.0465 0.2085)
+(-0.0060 -0.0435 0.2085)
+(-0.0030 -0.0435 0.2085)
+(0.0000 -0.0435 0.2085)
+(0.0030 -0.0435 0.2085)
+(0.0060 -0.0435 0.2085)
+(-0.0060 -0.0405 0.2085)
+(-0.0030 -0.0405 0.2085)
+(0.0000 -0.0405 0.2085)
+(0.0030 -0.0405 0.2085)
+(0.0060 -0.0405 0.2085)
+(-0.0060 -0.0375 0.2085)
+(-0.0030 -0.0375 0.2085)
+(0.0000 -0.0375 0.2085)
+(0.0030 -0.0375 0.2085)
+(0.0060 -0.0375 0.2085)
+(-0.0060 -0.0345 0.2085)
+(-0.0030 -0.0345 0.2085)
+(0.0000 -0.0345 0.2085)
+(0.0030 -0.0345 0.2085)
+(0.0060 -0.0345 0.2085)
+(-0.0060 -0.0315 0.2085)
+(-0.0030 -0.0315 0.2085)
+(0.0000 -0.0315 0.2085)
+(0.0030 -0.0315 0.2085)
+(0.0060 -0.0315 0.2085)
+(-0.0060 -0.0285 0.2085)
+(-0.0030 -0.0285 0.2085)
+(0.0000 -0.0285 0.2085)
+(0.0030 -0.0285 0.2085)
+(0.0060 -0.0285 0.2085)
+(-0.0060 -0.0255 0.2085)
+(-0.0030 -0.0255 0.2085)
+(0.0000 -0.0255 0.2085)
+(0.0030 -0.0255 0.2085)
+(0.0060 -0.0255 0.2085)
+(-0.0060 -0.0225 0.2085)
+(-0.0030 -0.0225 0.2085)
+(0.0000 -0.0225 0.2085)
+(0.0030 -0.0225 0.2085)
+(0.0060 -0.0225 0.2085)
+(-0.0060 -0.0195 0.2085)
+(-0.0030 -0.0195 0.2085)
+(0.0000 -0.0195 0.2085)
+(0.0030 -0.0195 0.2085)
+(0.0060 -0.0195 0.2085)
+(-0.0060 -0.0165 0.2085)
+(-0.0030 -0.0165 0.2085)
+(0.0000 -0.0165 0.2085)
+(0.0030 -0.0165 0.2085)
+(0.0060 -0.0165 0.2085)
+(-0.0060 -0.0135 0.2085)
+(-0.0030 -0.0135 0.2085)
+(0.0000 -0.0135 0.2085)
+(0.0030 -0.0135 0.2085)
+(0.0060 -0.0135 0.2085)
+(-0.0060 -0.0105 0.2085)
+(-0.0030 -0.0105 0.2085)
+(0.0000 -0.0105 0.2085)
+(0.0030 -0.0105 0.2085)
+(0.0060 -0.0105 0.2085)
+(-0.0060 -0.0075 0.2085)
+(-0.0030 -0.0075 0.2085)
+(0.0000 -0.0075 0.2085)
+(0.0030 -0.0075 0.2085)
+(0.0060 -0.0075 0.2085)
+(-0.0060 -0.0045 0.2085)
+(-0.0030 -0.0045 0.2085)
+(0.0000 -0.0045 0.2085)
+(0.0030 -0.0045 0.2085)
+(0.0060 -0.0045 0.2085)
+(-0.0060 -0.0015 0.2085)
+(-0.0030 -0.0015 0.2085)
+(0.0000 -0.0015 0.2085)
+(0.0030 -0.0015 0.2085)
+(0.0060 -0.0015 0.2085)
+(-0.0060 0.0015 0.2085)
+(-0.0030 0.0015 0.2085)
+(0.0000 0.0015 0.2085)
+(0.0030 0.0015 0.2085)
+(0.0060 0.0015 0.2085)
+(-0.0060 0.0045 0.2085)
+(-0.0030 0.0045 0.2085)
+(0.0000 0.0045 0.2085)
+(0.0030 0.0045 0.2085)
+(0.0060 0.0045 0.2085)
+(-0.0060 0.0075 0.2085)
+(-0.0030 0.0075 0.2085)
+(0.0000 0.0075 0.2085)
+(0.0030 0.0075 0.2085)
+(0.0060 0.0075 0.2085)
+(-0.0060 0.0105 0.2085)
+(-0.0030 0.0105 0.2085)
+(0.0000 0.0105 0.2085)
+(0.0030 0.0105 0.2085)
+(0.0060 0.0105 0.2085)
+(-0.0060 0.0135 0.2085)
+(-0.0030 0.0135 0.2085)
+(0.0000 0.0135 0.2085)
+(0.0030 0.0135 0.2085)
+(0.0060 0.0135 0.2085)
+(-0.0060 0.0165 0.2085)
+(-0.0030 0.0165 0.2085)
+(0.0000 0.0165 0.2085)
+(0.0030 0.0165 0.2085)
+(0.0060 0.0165 0.2085)
+(-0.0060 0.0195 0.2085)
+(-0.0030 0.0195 0.2085)
+(0.0000 0.0195 0.2085)
+(0.0030 0.0195 0.2085)
+(0.0060 0.0195 0.2085)
+(-0.0060 0.0225 0.2085)
+(-0.0030 0.0225 0.2085)
+(0.0000 0.0225 0.2085)
+(0.0030 0.0225 0.2085)
+(0.0060 0.0225 0.2085)
+(-0.0060 0.0255 0.2085)
+(-0.0030 0.0255 0.2085)
+(0.0000 0.0255 0.2085)
+(0.0030 0.0255 0.2085)
+(0.0060 0.0255 0.2085)
+(-0.0060 0.0285 0.2085)
+(-0.0030 0.0285 0.2085)
+(0.0000 0.0285 0.2085)
+(0.0030 0.0285 0.2085)
+(0.0060 0.0285 0.2085)
+(-0.0060 0.0315 0.2085)
+(-0.0030 0.0315 0.2085)
+(0.0000 0.0315 0.2085)
+(0.0030 0.0315 0.2085)
+(0.0060 0.0315 0.2085)
+(-0.0060 0.0345 0.2085)
+(-0.0030 0.0345 0.2085)
+(0.0000 0.0345 0.2085)
+(0.0030 0.0345 0.2085)
+(0.0060 0.0345 0.2085)
+(-0.0060 0.0375 0.2085)
+(-0.0030 0.0375 0.2085)
+(0.0000 0.0375 0.2085)
+(0.0030 0.0375 0.2085)
+(0.0060 0.0375 0.2085)
+(-0.0060 0.0405 0.2085)
+(-0.0030 0.0405 0.2085)
+(0.0000 0.0405 0.2085)
+(0.0030 0.0405 0.2085)
+(0.0060 0.0405 0.2085)
+(-0.0060 0.0435 0.2085)
+(-0.0030 0.0435 0.2085)
+(0.0000 0.0435 0.2085)
+(0.0030 0.0435 0.2085)
+(0.0060 0.0435 0.2085)
+(-0.0060 0.0465 0.2085)
+(-0.0030 0.0465 0.2085)
+(0.0000 0.0465 0.2085)
+(0.0030 0.0465 0.2085)
+(0.0060 0.0465 0.2085)
+(-0.0060 0.0495 0.2085)
+(-0.0030 0.0495 0.2085)
+(0.0000 0.0495 0.2085)
+(0.0030 0.0495 0.2085)
+(0.0060 0.0495 0.2085)
+(-0.0060 0.0525 0.2085)
+(-0.0030 0.0525 0.2085)
+(0.0000 0.0525 0.2085)
+(0.0030 0.0525 0.2085)
+(0.0060 0.0525 0.2085)
+(-0.0060 0.0555 0.2085)
+(-0.0030 0.0555 0.2085)
+(0.0000 0.0555 0.2085)
+(0.0030 0.0555 0.2085)
+(0.0060 0.0555 0.2085)
+(-0.0060 0.0585 0.2085)
+(-0.0030 0.0585 0.2085)
+(0.0000 0.0585 0.2085)
+(0.0030 0.0585 0.2085)
+(0.0060 0.0585 0.2085)
+(-0.0060 0.0615 0.2085)
+(-0.0030 0.0615 0.2085)
+(0.0000 0.0615 0.2085)
+(0.0030 0.0615 0.2085)
+(0.0060 0.0615 0.2085)
+(-0.0060 0.0645 0.2085)
+(-0.0030 0.0645 0.2085)
+(0.0000 0.0645 0.2085)
+(0.0030 0.0645 0.2085)
+(0.0060 0.0645 0.2085)
+(-0.0060 0.0675 0.2085)
+(-0.0030 0.0675 0.2085)
+(0.0000 0.0675 0.2085)
+(0.0030 0.0675 0.2085)
+(0.0060 0.0675 0.2085)
+(-0.0060 0.0705 0.2085)
+(-0.0030 0.0705 0.2085)
+(0.0000 0.0705 0.2085)
+(0.0030 0.0705 0.2085)
+(0.0060 0.0705 0.2085)
+(-0.0060 0.0735 0.2085)
+(-0.0030 0.0735 0.2085)
+(0.0000 0.0735 0.2085)
+(0.0030 0.0735 0.2085)
+(0.0060 0.0735 0.2085)
+(-0.0060 -0.0735 0.2115)
+(-0.0030 -0.0735 0.2115)
+(0.0000 -0.0735 0.2115)
+(0.0030 -0.0735 0.2115)
+(0.0060 -0.0735 0.2115)
+(-0.0060 -0.0705 0.2115)
+(-0.0030 -0.0705 0.2115)
+(0.0000 -0.0705 0.2115)
+(0.0030 -0.0705 0.2115)
+(0.0060 -0.0705 0.2115)
+(-0.0060 -0.0675 0.2115)
+(-0.0030 -0.0675 0.2115)
+(0.0000 -0.0675 0.2115)
+(0.0030 -0.0675 0.2115)
+(0.0060 -0.0675 0.2115)
+(-0.0060 -0.0645 0.2115)
+(-0.0030 -0.0645 0.2115)
+(0.0000 -0.0645 0.2115)
+(0.0030 -0.0645 0.2115)
+(0.0060 -0.0645 0.2115)
+(-0.0060 -0.0615 0.2115)
+(-0.0030 -0.0615 0.2115)
+(0.0000 -0.0615 0.2115)
+(0.0030 -0.0615 0.2115)
+(0.0060 -0.0615 0.2115)
+(-0.0060 -0.0585 0.2115)
+(-0.0030 -0.0585 0.2115)
+(0.0000 -0.0585 0.2115)
+(0.0030 -0.0585 0.2115)
+(0.0060 -0.0585 0.2115)
+(-0.0060 -0.0555 0.2115)
+(-0.0030 -0.0555 0.2115)
+(0.0000 -0.0555 0.2115)
+(0.0030 -0.0555 0.2115)
+(0.0060 -0.0555 0.2115)
+(-0.0060 -0.0525 0.2115)
+(-0.0030 -0.0525 0.2115)
+(0.0000 -0.0525 0.2115)
+(0.0030 -0.0525 0.2115)
+(0.0060 -0.0525 0.2115)
+(-0.0060 -0.0495 0.2115)
+(-0.0030 -0.0495 0.2115)
+(0.0000 -0.0495 0.2115)
+(0.0030 -0.0495 0.2115)
+(0.0060 -0.0495 0.2115)
+(-0.0060 -0.0465 0.2115)
+(-0.0030 -0.0465 0.2115)
+(0.0000 -0.0465 0.2115)
+(0.0030 -0.0465 0.2115)
+(0.0060 -0.0465 0.2115)
+(-0.0060 -0.0435 0.2115)
+(-0.0030 -0.0435 0.2115)
+(0.0000 -0.0435 0.2115)
+(0.0030 -0.0435 0.2115)
+(0.0060 -0.0435 0.2115)
+(-0.0060 -0.0405 0.2115)
+(-0.0030 -0.0405 0.2115)
+(0.0000 -0.0405 0.2115)
+(0.0030 -0.0405 0.2115)
+(0.0060 -0.0405 0.2115)
+(-0.0060 -0.0375 0.2115)
+(-0.0030 -0.0375 0.2115)
+(0.0000 -0.0375 0.2115)
+(0.0030 -0.0375 0.2115)
+(0.0060 -0.0375 0.2115)
+(-0.0060 -0.0345 0.2115)
+(-0.0030 -0.0345 0.2115)
+(0.0000 -0.0345 0.2115)
+(0.0030 -0.0345 0.2115)
+(0.0060 -0.0345 0.2115)
+(-0.0060 -0.0315 0.2115)
+(-0.0030 -0.0315 0.2115)
+(0.0000 -0.0315 0.2115)
+(0.0030 -0.0315 0.2115)
+(0.0060 -0.0315 0.2115)
+(-0.0060 -0.0285 0.2115)
+(-0.0030 -0.0285 0.2115)
+(0.0000 -0.0285 0.2115)
+(0.0030 -0.0285 0.2115)
+(0.0060 -0.0285 0.2115)
+(-0.0060 -0.0255 0.2115)
+(-0.0030 -0.0255 0.2115)
+(0.0000 -0.0255 0.2115)
+(0.0030 -0.0255 0.2115)
+(0.0060 -0.0255 0.2115)
+(-0.0060 -0.0225 0.2115)
+(-0.0030 -0.0225 0.2115)
+(0.0000 -0.0225 0.2115)
+(0.0030 -0.0225 0.2115)
+(0.0060 -0.0225 0.2115)
+(-0.0060 -0.0195 0.2115)
+(-0.0030 -0.0195 0.2115)
+(0.0000 -0.0195 0.2115)
+(0.0030 -0.0195 0.2115)
+(0.0060 -0.0195 0.2115)
+(-0.0060 -0.0165 0.2115)
+(-0.0030 -0.0165 0.2115)
+(0.0000 -0.0165 0.2115)
+(0.0030 -0.0165 0.2115)
+(0.0060 -0.0165 0.2115)
+(-0.0060 -0.0135 0.2115)
+(-0.0030 -0.0135 0.2115)
+(0.0000 -0.0135 0.2115)
+(0.0030 -0.0135 0.2115)
+(0.0060 -0.0135 0.2115)
+(-0.0060 -0.0105 0.2115)
+(-0.0030 -0.0105 0.2115)
+(0.0000 -0.0105 0.2115)
+(0.0030 -0.0105 0.2115)
+(0.0060 -0.0105 0.2115)
+(-0.0060 -0.0075 0.2115)
+(-0.0030 -0.0075 0.2115)
+(0.0000 -0.0075 0.2115)
+(0.0030 -0.0075 0.2115)
+(0.0060 -0.0075 0.2115)
+(-0.0060 -0.0045 0.2115)
+(-0.0030 -0.0045 0.2115)
+(0.0000 -0.0045 0.2115)
+(0.0030 -0.0045 0.2115)
+(0.0060 -0.0045 0.2115)
+(-0.0060 -0.0015 0.2115)
+(-0.0030 -0.0015 0.2115)
+(0.0000 -0.0015 0.2115)
+(0.0030 -0.0015 0.2115)
+(0.0060 -0.0015 0.2115)
+(-0.0060 0.0015 0.2115)
+(-0.0030 0.0015 0.2115)
+(0.0000 0.0015 0.2115)
+(0.0030 0.0015 0.2115)
+(0.0060 0.0015 0.2115)
+(-0.0060 0.0045 0.2115)
+(-0.0030 0.0045 0.2115)
+(0.0000 0.0045 0.2115)
+(0.0030 0.0045 0.2115)
+(0.0060 0.0045 0.2115)
+(-0.0060 0.0075 0.2115)
+(-0.0030 0.0075 0.2115)
+(0.0000 0.0075 0.2115)
+(0.0030 0.0075 0.2115)
+(0.0060 0.0075 0.2115)
+(-0.0060 0.0105 0.2115)
+(-0.0030 0.0105 0.2115)
+(0.0000 0.0105 0.2115)
+(0.0030 0.0105 0.2115)
+(0.0060 0.0105 0.2115)
+(-0.0060 0.0135 0.2115)
+(-0.0030 0.0135 0.2115)
+(0.0000 0.0135 0.2115)
+(0.0030 0.0135 0.2115)
+(0.0060 0.0135 0.2115)
+(-0.0060 0.0165 0.2115)
+(-0.0030 0.0165 0.2115)
+(0.0000 0.0165 0.2115)
+(0.0030 0.0165 0.2115)
+(0.0060 0.0165 0.2115)
+(-0.0060 0.0195 0.2115)
+(-0.0030 0.0195 0.2115)
+(0.0000 0.0195 0.2115)
+(0.0030 0.0195 0.2115)
+(0.0060 0.0195 0.2115)
+(-0.0060 0.0225 0.2115)
+(-0.0030 0.0225 0.2115)
+(0.0000 0.0225 0.2115)
+(0.0030 0.0225 0.2115)
+(0.0060 0.0225 0.2115)
+(-0.0060 0.0255 0.2115)
+(-0.0030 0.0255 0.2115)
+(0.0000 0.0255 0.2115)
+(0.0030 0.0255 0.2115)
+(0.0060 0.0255 0.2115)
+(-0.0060 0.0285 0.2115)
+(-0.0030 0.0285 0.2115)
+(0.0000 0.0285 0.2115)
+(0.0030 0.0285 0.2115)
+(0.0060 0.0285 0.2115)
+(-0.0060 0.0315 0.2115)
+(-0.0030 0.0315 0.2115)
+(0.0000 0.0315 0.2115)
+(0.0030 0.0315 0.2115)
+(0.0060 0.0315 0.2115)
+(-0.0060 0.0345 0.2115)
+(-0.0030 0.0345 0.2115)
+(0.0000 0.0345 0.2115)
+(0.0030 0.0345 0.2115)
+(0.0060 0.0345 0.2115)
+(-0.0060 0.0375 0.2115)
+(-0.0030 0.0375 0.2115)
+(0.0000 0.0375 0.2115)
+(0.0030 0.0375 0.2115)
+(0.0060 0.0375 0.2115)
+(-0.0060 0.0405 0.2115)
+(-0.0030 0.0405 0.2115)
+(0.0000 0.0405 0.2115)
+(0.0030 0.0405 0.2115)
+(0.0060 0.0405 0.2115)
+(-0.0060 0.0435 0.2115)
+(-0.0030 0.0435 0.2115)
+(0.0000 0.0435 0.2115)
+(0.0030 0.0435 0.2115)
+(0.0060 0.0435 0.2115)
+(-0.0060 0.0465 0.2115)
+(-0.0030 0.0465 0.2115)
+(0.0000 0.0465 0.2115)
+(0.0030 0.0465 0.2115)
+(0.0060 0.0465 0.2115)
+(-0.0060 0.0495 0.2115)
+(-0.0030 0.0495 0.2115)
+(0.0000 0.0495 0.2115)
+(0.0030 0.0495 0.2115)
+(0.0060 0.0495 0.2115)
+(-0.0060 0.0525 0.2115)
+(-0.0030 0.0525 0.2115)
+(0.0000 0.0525 0.2115)
+(0.0030 0.0525 0.2115)
+(0.0060 0.0525 0.2115)
+(-0.0060 0.0555 0.2115)
+(-0.0030 0.0555 0.2115)
+(0.0000 0.0555 0.2115)
+(0.0030 0.0555 0.2115)
+(0.0060 0.0555 0.2115)
+(-0.0060 0.0585 0.2115)
+(-0.0030 0.0585 0.2115)
+(0.0000 0.0585 0.2115)
+(0.0030 0.0585 0.2115)
+(0.0060 0.0585 0.2115)
+(-0.0060 0.0615 0.2115)
+(-0.0030 0.0615 0.2115)
+(0.0000 0.0615 0.2115)
+(0.0030 0.0615 0.2115)
+(0.0060 0.0615 0.2115)
+(-0.0060 0.0645 0.2115)
+(-0.0030 0.0645 0.2115)
+(0.0000 0.0645 0.2115)
+(0.0030 0.0645 0.2115)
+(0.0060 0.0645 0.2115)
+(-0.0060 0.0675 0.2115)
+(-0.0030 0.0675 0.2115)
+(0.0000 0.0675 0.2115)
+(0.0030 0.0675 0.2115)
+(0.0060 0.0675 0.2115)
+(-0.0060 0.0705 0.2115)
+(-0.0030 0.0705 0.2115)
+(0.0000 0.0705 0.2115)
+(0.0030 0.0705 0.2115)
+(0.0060 0.0705 0.2115)
+(-0.0060 0.0735 0.2115)
+(-0.0030 0.0735 0.2115)
+(0.0000 0.0735 0.2115)
+(0.0030 0.0735 0.2115)
+(0.0060 0.0735 0.2115)
+(-0.0060 -0.0735 0.2145)
+(-0.0030 -0.0735 0.2145)
+(0.0000 -0.0735 0.2145)
+(0.0030 -0.0735 0.2145)
+(0.0060 -0.0735 0.2145)
+(-0.0060 -0.0705 0.2145)
+(-0.0030 -0.0705 0.2145)
+(0.0000 -0.0705 0.2145)
+(0.0030 -0.0705 0.2145)
+(0.0060 -0.0705 0.2145)
+(-0.0060 -0.0675 0.2145)
+(-0.0030 -0.0675 0.2145)
+(0.0000 -0.0675 0.2145)
+(0.0030 -0.0675 0.2145)
+(0.0060 -0.0675 0.2145)
+(-0.0060 -0.0645 0.2145)
+(-0.0030 -0.0645 0.2145)
+(0.0000 -0.0645 0.2145)
+(0.0030 -0.0645 0.2145)
+(0.0060 -0.0645 0.2145)
+(-0.0060 -0.0615 0.2145)
+(-0.0030 -0.0615 0.2145)
+(0.0000 -0.0615 0.2145)
+(0.0030 -0.0615 0.2145)
+(0.0060 -0.0615 0.2145)
+(-0.0060 -0.0585 0.2145)
+(-0.0030 -0.0585 0.2145)
+(0.0000 -0.0585 0.2145)
+(0.0030 -0.0585 0.2145)
+(0.0060 -0.0585 0.2145)
+(-0.0060 -0.0555 0.2145)
+(-0.0030 -0.0555 0.2145)
+(0.0000 -0.0555 0.2145)
+(0.0030 -0.0555 0.2145)
+(0.0060 -0.0555 0.2145)
+(-0.0060 -0.0525 0.2145)
+(-0.0030 -0.0525 0.2145)
+(0.0000 -0.0525 0.2145)
+(0.0030 -0.0525 0.2145)
+(0.0060 -0.0525 0.2145)
+(-0.0060 -0.0495 0.2145)
+(-0.0030 -0.0495 0.2145)
+(0.0000 -0.0495 0.2145)
+(0.0030 -0.0495 0.2145)
+(0.0060 -0.0495 0.2145)
+(-0.0060 -0.0465 0.2145)
+(-0.0030 -0.0465 0.2145)
+(0.0000 -0.0465 0.2145)
+(0.0030 -0.0465 0.2145)
+(0.0060 -0.0465 0.2145)
+(-0.0060 -0.0435 0.2145)
+(-0.0030 -0.0435 0.2145)
+(0.0000 -0.0435 0.2145)
+(0.0030 -0.0435 0.2145)
+(0.0060 -0.0435 0.2145)
+(-0.0060 -0.0405 0.2145)
+(-0.0030 -0.0405 0.2145)
+(0.0000 -0.0405 0.2145)
+(0.0030 -0.0405 0.2145)
+(0.0060 -0.0405 0.2145)
+(-0.0060 -0.0375 0.2145)
+(-0.0030 -0.0375 0.2145)
+(0.0000 -0.0375 0.2145)
+(0.0030 -0.0375 0.2145)
+(0.0060 -0.0375 0.2145)
+(-0.0060 -0.0345 0.2145)
+(-0.0030 -0.0345 0.2145)
+(0.0000 -0.0345 0.2145)
+(0.0030 -0.0345 0.2145)
+(0.0060 -0.0345 0.2145)
+(-0.0060 -0.0315 0.2145)
+(-0.0030 -0.0315 0.2145)
+(0.0000 -0.0315 0.2145)
+(0.0030 -0.0315 0.2145)
+(0.0060 -0.0315 0.2145)
+(-0.0060 -0.0285 0.2145)
+(-0.0030 -0.0285 0.2145)
+(0.0000 -0.0285 0.2145)
+(0.0030 -0.0285 0.2145)
+(0.0060 -0.0285 0.2145)
+(-0.0060 -0.0255 0.2145)
+(-0.0030 -0.0255 0.2145)
+(0.0000 -0.0255 0.2145)
+(0.0030 -0.0255 0.2145)
+(0.0060 -0.0255 0.2145)
+(-0.0060 -0.0225 0.2145)
+(-0.0030 -0.0225 0.2145)
+(0.0000 -0.0225 0.2145)
+(0.0030 -0.0225 0.2145)
+(0.0060 -0.0225 0.2145)
+(-0.0060 -0.0195 0.2145)
+(-0.0030 -0.0195 0.2145)
+(0.0000 -0.0195 0.2145)
+(0.0030 -0.0195 0.2145)
+(0.0060 -0.0195 0.2145)
+(-0.0060 -0.0165 0.2145)
+(-0.0030 -0.0165 0.2145)
+(0.0000 -0.0165 0.2145)
+(0.0030 -0.0165 0.2145)
+(0.0060 -0.0165 0.2145)
+(-0.0060 -0.0135 0.2145)
+(-0.0030 -0.0135 0.2145)
+(0.0000 -0.0135 0.2145)
+(0.0030 -0.0135 0.2145)
+(0.0060 -0.0135 0.2145)
+(-0.0060 -0.0105 0.2145)
+(-0.0030 -0.0105 0.2145)
+(0.0000 -0.0105 0.2145)
+(0.0030 -0.0105 0.2145)
+(0.0060 -0.0105 0.2145)
+(-0.0060 -0.0075 0.2145)
+(-0.0030 -0.0075 0.2145)
+(0.0000 -0.0075 0.2145)
+(0.0030 -0.0075 0.2145)
+(0.0060 -0.0075 0.2145)
+(-0.0060 -0.0045 0.2145)
+(-0.0030 -0.0045 0.2145)
+(0.0000 -0.0045 0.2145)
+(0.0030 -0.0045 0.2145)
+(0.0060 -0.0045 0.2145)
+(-0.0060 -0.0015 0.2145)
+(-0.0030 -0.0015 0.2145)
+(0.0000 -0.0015 0.2145)
+(0.0030 -0.0015 0.2145)
+(0.0060 -0.0015 0.2145)
+(-0.0060 0.0015 0.2145)
+(-0.0030 0.0015 0.2145)
+(0.0000 0.0015 0.2145)
+(0.0030 0.0015 0.2145)
+(0.0060 0.0015 0.2145)
+(-0.0060 0.0045 0.2145)
+(-0.0030 0.0045 0.2145)
+(0.0000 0.0045 0.2145)
+(0.0030 0.0045 0.2145)
+(0.0060 0.0045 0.2145)
+(-0.0060 0.0075 0.2145)
+(-0.0030 0.0075 0.2145)
+(0.0000 0.0075 0.2145)
+(0.0030 0.0075 0.2145)
+(0.0060 0.0075 0.2145)
+(-0.0060 0.0105 0.2145)
+(-0.0030 0.0105 0.2145)
+(0.0000 0.0105 0.2145)
+(0.0030 0.0105 0.2145)
+(0.0060 0.0105 0.2145)
+(-0.0060 0.0135 0.2145)
+(-0.0030 0.0135 0.2145)
+(0.0000 0.0135 0.2145)
+(0.0030 0.0135 0.2145)
+(0.0060 0.0135 0.2145)
+(-0.0060 0.0165 0.2145)
+(-0.0030 0.0165 0.2145)
+(0.0000 0.0165 0.2145)
+(0.0030 0.0165 0.2145)
+(0.0060 0.0165 0.2145)
+(-0.0060 0.0195 0.2145)
+(-0.0030 0.0195 0.2145)
+(0.0000 0.0195 0.2145)
+(0.0030 0.0195 0.2145)
+(0.0060 0.0195 0.2145)
+(-0.0060 0.0225 0.2145)
+(-0.0030 0.0225 0.2145)
+(0.0000 0.0225 0.2145)
+(0.0030 0.0225 0.2145)
+(0.0060 0.0225 0.2145)
+(-0.0060 0.0255 0.2145)
+(-0.0030 0.0255 0.2145)
+(0.0000 0.0255 0.2145)
+(0.0030 0.0255 0.2145)
+(0.0060 0.0255 0.2145)
+(-0.0060 0.0285 0.2145)
+(-0.0030 0.0285 0.2145)
+(0.0000 0.0285 0.2145)
+(0.0030 0.0285 0.2145)
+(0.0060 0.0285 0.2145)
+(-0.0060 0.0315 0.2145)
+(-0.0030 0.0315 0.2145)
+(0.0000 0.0315 0.2145)
+(0.0030 0.0315 0.2145)
+(0.0060 0.0315 0.2145)
+(-0.0060 0.0345 0.2145)
+(-0.0030 0.0345 0.2145)
+(0.0000 0.0345 0.2145)
+(0.0030 0.0345 0.2145)
+(0.0060 0.0345 0.2145)
+(-0.0060 0.0375 0.2145)
+(-0.0030 0.0375 0.2145)
+(0.0000 0.0375 0.2145)
+(0.0030 0.0375 0.2145)
+(0.0060 0.0375 0.2145)
+(-0.0060 0.0405 0.2145)
+(-0.0030 0.0405 0.2145)
+(0.0000 0.0405 0.2145)
+(0.0030 0.0405 0.2145)
+(0.0060 0.0405 0.2145)
+(-0.0060 0.0435 0.2145)
+(-0.0030 0.0435 0.2145)
+(0.0000 0.0435 0.2145)
+(0.0030 0.0435 0.2145)
+(0.0060 0.0435 0.2145)
+(-0.0060 0.0465 0.2145)
+(-0.0030 0.0465 0.2145)
+(0.0000 0.0465 0.2145)
+(0.0030 0.0465 0.2145)
+(0.0060 0.0465 0.2145)
+(-0.0060 0.0495 0.2145)
+(-0.0030 0.0495 0.2145)
+(0.0000 0.0495 0.2145)
+(0.0030 0.0495 0.2145)
+(0.0060 0.0495 0.2145)
+(-0.0060 0.0525 0.2145)
+(-0.0030 0.0525 0.2145)
+(0.0000 0.0525 0.2145)
+(0.0030 0.0525 0.2145)
+(0.0060 0.0525 0.2145)
+(-0.0060 0.0555 0.2145)
+(-0.0030 0.0555 0.2145)
+(0.0000 0.0555 0.2145)
+(0.0030 0.0555 0.2145)
+(0.0060 0.0555 0.2145)
+(-0.0060 0.0585 0.2145)
+(-0.0030 0.0585 0.2145)
+(0.0000 0.0585 0.2145)
+(0.0030 0.0585 0.2145)
+(0.0060 0.0585 0.2145)
+(-0.0060 0.0615 0.2145)
+(-0.0030 0.0615 0.2145)
+(0.0000 0.0615 0.2145)
+(0.0030 0.0615 0.2145)
+(0.0060 0.0615 0.2145)
+(-0.0060 0.0645 0.2145)
+(-0.0030 0.0645 0.2145)
+(0.0000 0.0645 0.2145)
+(0.0030 0.0645 0.2145)
+(0.0060 0.0645 0.2145)
+(-0.0060 0.0675 0.2145)
+(-0.0030 0.0675 0.2145)
+(0.0000 0.0675 0.2145)
+(0.0030 0.0675 0.2145)
+(0.0060 0.0675 0.2145)
+(-0.0060 0.0705 0.2145)
+(-0.0030 0.0705 0.2145)
+(0.0000 0.0705 0.2145)
+(0.0030 0.0705 0.2145)
+(0.0060 0.0705 0.2145)
+(-0.0060 0.0735 0.2145)
+(-0.0030 0.0735 0.2145)
+(0.0000 0.0735 0.2145)
+(0.0030 0.0735 0.2145)
+(0.0060 0.0735 0.2145)
+(-0.0060 -0.0735 0.2175)
+(-0.0030 -0.0735 0.2175)
+(0.0000 -0.0735 0.2175)
+(0.0030 -0.0735 0.2175)
+(0.0060 -0.0735 0.2175)
+(-0.0060 -0.0705 0.2175)
+(-0.0030 -0.0705 0.2175)
+(0.0000 -0.0705 0.2175)
+(0.0030 -0.0705 0.2175)
+(0.0060 -0.0705 0.2175)
+(-0.0060 -0.0675 0.2175)
+(-0.0030 -0.0675 0.2175)
+(0.0000 -0.0675 0.2175)
+(0.0030 -0.0675 0.2175)
+(0.0060 -0.0675 0.2175)
+(-0.0060 -0.0645 0.2175)
+(-0.0030 -0.0645 0.2175)
+(0.0000 -0.0645 0.2175)
+(0.0030 -0.0645 0.2175)
+(0.0060 -0.0645 0.2175)
+(-0.0060 -0.0615 0.2175)
+(-0.0030 -0.0615 0.2175)
+(0.0000 -0.0615 0.2175)
+(0.0030 -0.0615 0.2175)
+(0.0060 -0.0615 0.2175)
+(-0.0060 -0.0585 0.2175)
+(-0.0030 -0.0585 0.2175)
+(0.0000 -0.0585 0.2175)
+(0.0030 -0.0585 0.2175)
+(0.0060 -0.0585 0.2175)
+(-0.0060 -0.0555 0.2175)
+(-0.0030 -0.0555 0.2175)
+(0.0000 -0.0555 0.2175)
+(0.0030 -0.0555 0.2175)
+(0.0060 -0.0555 0.2175)
+(-0.0060 -0.0525 0.2175)
+(-0.0030 -0.0525 0.2175)
+(0.0000 -0.0525 0.2175)
+(0.0030 -0.0525 0.2175)
+(0.0060 -0.0525 0.2175)
+(-0.0060 -0.0495 0.2175)
+(-0.0030 -0.0495 0.2175)
+(0.0000 -0.0495 0.2175)
+(0.0030 -0.0495 0.2175)
+(0.0060 -0.0495 0.2175)
+(-0.0060 -0.0465 0.2175)
+(-0.0030 -0.0465 0.2175)
+(0.0000 -0.0465 0.2175)
+(0.0030 -0.0465 0.2175)
+(0.0060 -0.0465 0.2175)
+(-0.0060 -0.0435 0.2175)
+(-0.0030 -0.0435 0.2175)
+(0.0000 -0.0435 0.2175)
+(0.0030 -0.0435 0.2175)
+(0.0060 -0.0435 0.2175)
+(-0.0060 -0.0405 0.2175)
+(-0.0030 -0.0405 0.2175)
+(0.0000 -0.0405 0.2175)
+(0.0030 -0.0405 0.2175)
+(0.0060 -0.0405 0.2175)
+(-0.0060 -0.0375 0.2175)
+(-0.0030 -0.0375 0.2175)
+(0.0000 -0.0375 0.2175)
+(0.0030 -0.0375 0.2175)
+(0.0060 -0.0375 0.2175)
+(-0.0060 -0.0345 0.2175)
+(-0.0030 -0.0345 0.2175)
+(0.0000 -0.0345 0.2175)
+(0.0030 -0.0345 0.2175)
+(0.0060 -0.0345 0.2175)
+(-0.0060 -0.0315 0.2175)
+(-0.0030 -0.0315 0.2175)
+(0.0000 -0.0315 0.2175)
+(0.0030 -0.0315 0.2175)
+(0.0060 -0.0315 0.2175)
+(-0.0060 -0.0285 0.2175)
+(-0.0030 -0.0285 0.2175)
+(0.0000 -0.0285 0.2175)
+(0.0030 -0.0285 0.2175)
+(0.0060 -0.0285 0.2175)
+(-0.0060 -0.0255 0.2175)
+(-0.0030 -0.0255 0.2175)
+(0.0000 -0.0255 0.2175)
+(0.0030 -0.0255 0.2175)
+(0.0060 -0.0255 0.2175)
+(-0.0060 -0.0225 0.2175)
+(-0.0030 -0.0225 0.2175)
+(0.0000 -0.0225 0.2175)
+(0.0030 -0.0225 0.2175)
+(0.0060 -0.0225 0.2175)
+(-0.0060 -0.0195 0.2175)
+(-0.0030 -0.0195 0.2175)
+(0.0000 -0.0195 0.2175)
+(0.0030 -0.0195 0.2175)
+(0.0060 -0.0195 0.2175)
+(-0.0060 -0.0165 0.2175)
+(-0.0030 -0.0165 0.2175)
+(0.0000 -0.0165 0.2175)
+(0.0030 -0.0165 0.2175)
+(0.0060 -0.0165 0.2175)
+(-0.0060 -0.0135 0.2175)
+(-0.0030 -0.0135 0.2175)
+(0.0000 -0.0135 0.2175)
+(0.0030 -0.0135 0.2175)
+(0.0060 -0.0135 0.2175)
+(-0.0060 -0.0105 0.2175)
+(-0.0030 -0.0105 0.2175)
+(0.0000 -0.0105 0.2175)
+(0.0030 -0.0105 0.2175)
+(0.0060 -0.0105 0.2175)
+(-0.0060 -0.0075 0.2175)
+(-0.0030 -0.0075 0.2175)
+(0.0000 -0.0075 0.2175)
+(0.0030 -0.0075 0.2175)
+(0.0060 -0.0075 0.2175)
+(-0.0060 -0.0045 0.2175)
+(-0.0030 -0.0045 0.2175)
+(0.0000 -0.0045 0.2175)
+(0.0030 -0.0045 0.2175)
+(0.0060 -0.0045 0.2175)
+(-0.0060 -0.0015 0.2175)
+(-0.0030 -0.0015 0.2175)
+(0.0000 -0.0015 0.2175)
+(0.0030 -0.0015 0.2175)
+(0.0060 -0.0015 0.2175)
+(-0.0060 0.0015 0.2175)
+(-0.0030 0.0015 0.2175)
+(0.0000 0.0015 0.2175)
+(0.0030 0.0015 0.2175)
+(0.0060 0.0015 0.2175)
+(-0.0060 0.0045 0.2175)
+(-0.0030 0.0045 0.2175)
+(0.0000 0.0045 0.2175)
+(0.0030 0.0045 0.2175)
+(0.0060 0.0045 0.2175)
+(-0.0060 0.0075 0.2175)
+(-0.0030 0.0075 0.2175)
+(0.0000 0.0075 0.2175)
+(0.0030 0.0075 0.2175)
+(0.0060 0.0075 0.2175)
+(-0.0060 0.0105 0.2175)
+(-0.0030 0.0105 0.2175)
+(0.0000 0.0105 0.2175)
+(0.0030 0.0105 0.2175)
+(0.0060 0.0105 0.2175)
+(-0.0060 0.0135 0.2175)
+(-0.0030 0.0135 0.2175)
+(0.0000 0.0135 0.2175)
+(0.0030 0.0135 0.2175)
+(0.0060 0.0135 0.2175)
+(-0.0060 0.0165 0.2175)
+(-0.0030 0.0165 0.2175)
+(0.0000 0.0165 0.2175)
+(0.0030 0.0165 0.2175)
+(0.0060 0.0165 0.2175)
+(-0.0060 0.0195 0.2175)
+(-0.0030 0.0195 0.2175)
+(0.0000 0.0195 0.2175)
+(0.0030 0.0195 0.2175)
+(0.0060 0.0195 0.2175)
+(-0.0060 0.0225 0.2175)
+(-0.0030 0.0225 0.2175)
+(0.0000 0.0225 0.2175)
+(0.0030 0.0225 0.2175)
+(0.0060 0.0225 0.2175)
+(-0.0060 0.0255 0.2175)
+(-0.0030 0.0255 0.2175)
+(0.0000 0.0255 0.2175)
+(0.0030 0.0255 0.2175)
+(0.0060 0.0255 0.2175)
+(-0.0060 0.0285 0.2175)
+(-0.0030 0.0285 0.2175)
+(0.0000 0.0285 0.2175)
+(0.0030 0.0285 0.2175)
+(0.0060 0.0285 0.2175)
+(-0.0060 0.0315 0.2175)
+(-0.0030 0.0315 0.2175)
+(0.0000 0.0315 0.2175)
+(0.0030 0.0315 0.2175)
+(0.0060 0.0315 0.2175)
+(-0.0060 0.0345 0.2175)
+(-0.0030 0.0345 0.2175)
+(0.0000 0.0345 0.2175)
+(0.0030 0.0345 0.2175)
+(0.0060 0.0345 0.2175)
+(-0.0060 0.0375 0.2175)
+(-0.0030 0.0375 0.2175)
+(0.0000 0.0375 0.2175)
+(0.0030 0.0375 0.2175)
+(0.0060 0.0375 0.2175)
+(-0.0060 0.0405 0.2175)
+(-0.0030 0.0405 0.2175)
+(0.0000 0.0405 0.2175)
+(0.0030 0.0405 0.2175)
+(0.0060 0.0405 0.2175)
+(-0.0060 0.0435 0.2175)
+(-0.0030 0.0435 0.2175)
+(0.0000 0.0435 0.2175)
+(0.0030 0.0435 0.2175)
+(0.0060 0.0435 0.2175)
+(-0.0060 0.0465 0.2175)
+(-0.0030 0.0465 0.2175)
+(0.0000 0.0465 0.2175)
+(0.0030 0.0465 0.2175)
+(0.0060 0.0465 0.2175)
+(-0.0060 0.0495 0.2175)
+(-0.0030 0.0495 0.2175)
+(0.0000 0.0495 0.2175)
+(0.0030 0.0495 0.2175)
+(0.0060 0.0495 0.2175)
+(-0.0060 0.0525 0.2175)
+(-0.0030 0.0525 0.2175)
+(0.0000 0.0525 0.2175)
+(0.0030 0.0525 0.2175)
+(0.0060 0.0525 0.2175)
+(-0.0060 0.0555 0.2175)
+(-0.0030 0.0555 0.2175)
+(0.0000 0.0555 0.2175)
+(0.0030 0.0555 0.2175)
+(0.0060 0.0555 0.2175)
+(-0.0060 0.0585 0.2175)
+(-0.0030 0.0585 0.2175)
+(0.0000 0.0585 0.2175)
+(0.0030 0.0585 0.2175)
+(0.0060 0.0585 0.2175)
+(-0.0060 0.0615 0.2175)
+(-0.0030 0.0615 0.2175)
+(0.0000 0.0615 0.2175)
+(0.0030 0.0615 0.2175)
+(0.0060 0.0615 0.2175)
+(-0.0060 0.0645 0.2175)
+(-0.0030 0.0645 0.2175)
+(0.0000 0.0645 0.2175)
+(0.0030 0.0645 0.2175)
+(0.0060 0.0645 0.2175)
+(-0.0060 0.0675 0.2175)
+(-0.0030 0.0675 0.2175)
+(0.0000 0.0675 0.2175)
+(0.0030 0.0675 0.2175)
+(0.0060 0.0675 0.2175)
+(-0.0060 0.0705 0.2175)
+(-0.0030 0.0705 0.2175)
+(0.0000 0.0705 0.2175)
+(0.0030 0.0705 0.2175)
+(0.0060 0.0705 0.2175)
+(-0.0060 0.0735 0.2175)
+(-0.0030 0.0735 0.2175)
+(0.0000 0.0735 0.2175)
+(0.0030 0.0735 0.2175)
+(0.0060 0.0735 0.2175)
+(-0.0060 -0.0735 0.2205)
+(-0.0030 -0.0735 0.2205)
+(0.0000 -0.0735 0.2205)
+(0.0030 -0.0735 0.2205)
+(0.0060 -0.0735 0.2205)
+(-0.0060 -0.0705 0.2205)
+(-0.0030 -0.0705 0.2205)
+(0.0000 -0.0705 0.2205)
+(0.0030 -0.0705 0.2205)
+(0.0060 -0.0705 0.2205)
+(-0.0060 -0.0675 0.2205)
+(-0.0030 -0.0675 0.2205)
+(0.0000 -0.0675 0.2205)
+(0.0030 -0.0675 0.2205)
+(0.0060 -0.0675 0.2205)
+(-0.0060 -0.0645 0.2205)
+(-0.0030 -0.0645 0.2205)
+(0.0000 -0.0645 0.2205)
+(0.0030 -0.0645 0.2205)
+(0.0060 -0.0645 0.2205)
+(-0.0060 -0.0615 0.2205)
+(-0.0030 -0.0615 0.2205)
+(0.0000 -0.0615 0.2205)
+(0.0030 -0.0615 0.2205)
+(0.0060 -0.0615 0.2205)
+(-0.0060 -0.0585 0.2205)
+(-0.0030 -0.0585 0.2205)
+(0.0000 -0.0585 0.2205)
+(0.0030 -0.0585 0.2205)
+(0.0060 -0.0585 0.2205)
+(-0.0060 -0.0555 0.2205)
+(-0.0030 -0.0555 0.2205)
+(0.0000 -0.0555 0.2205)
+(0.0030 -0.0555 0.2205)
+(0.0060 -0.0555 0.2205)
+(-0.0060 -0.0525 0.2205)
+(-0.0030 -0.0525 0.2205)
+(0.0000 -0.0525 0.2205)
+(0.0030 -0.0525 0.2205)
+(0.0060 -0.0525 0.2205)
+(-0.0060 -0.0495 0.2205)
+(-0.0030 -0.0495 0.2205)
+(0.0000 -0.0495 0.2205)
+(0.0030 -0.0495 0.2205)
+(0.0060 -0.0495 0.2205)
+(-0.0060 -0.0465 0.2205)
+(-0.0030 -0.0465 0.2205)
+(0.0000 -0.0465 0.2205)
+(0.0030 -0.0465 0.2205)
+(0.0060 -0.0465 0.2205)
+(-0.0060 -0.0435 0.2205)
+(-0.0030 -0.0435 0.2205)
+(0.0000 -0.0435 0.2205)
+(0.0030 -0.0435 0.2205)
+(0.0060 -0.0435 0.2205)
+(-0.0060 -0.0405 0.2205)
+(-0.0030 -0.0405 0.2205)
+(0.0000 -0.0405 0.2205)
+(0.0030 -0.0405 0.2205)
+(0.0060 -0.0405 0.2205)
+(-0.0060 -0.0375 0.2205)
+(-0.0030 -0.0375 0.2205)
+(0.0000 -0.0375 0.2205)
+(0.0030 -0.0375 0.2205)
+(0.0060 -0.0375 0.2205)
+(-0.0060 -0.0345 0.2205)
+(-0.0030 -0.0345 0.2205)
+(0.0000 -0.0345 0.2205)
+(0.0030 -0.0345 0.2205)
+(0.0060 -0.0345 0.2205)
+(-0.0060 -0.0315 0.2205)
+(-0.0030 -0.0315 0.2205)
+(0.0000 -0.0315 0.2205)
+(0.0030 -0.0315 0.2205)
+(0.0060 -0.0315 0.2205)
+(-0.0060 -0.0285 0.2205)
+(-0.0030 -0.0285 0.2205)
+(0.0000 -0.0285 0.2205)
+(0.0030 -0.0285 0.2205)
+(0.0060 -0.0285 0.2205)
+(-0.0060 -0.0255 0.2205)
+(-0.0030 -0.0255 0.2205)
+(0.0000 -0.0255 0.2205)
+(0.0030 -0.0255 0.2205)
+(0.0060 -0.0255 0.2205)
+(-0.0060 -0.0225 0.2205)
+(-0.0030 -0.0225 0.2205)
+(0.0000 -0.0225 0.2205)
+(0.0030 -0.0225 0.2205)
+(0.0060 -0.0225 0.2205)
+(-0.0060 -0.0195 0.2205)
+(-0.0030 -0.0195 0.2205)
+(0.0000 -0.0195 0.2205)
+(0.0030 -0.0195 0.2205)
+(0.0060 -0.0195 0.2205)
+(-0.0060 -0.0165 0.2205)
+(-0.0030 -0.0165 0.2205)
+(0.0000 -0.0165 0.2205)
+(0.0030 -0.0165 0.2205)
+(0.0060 -0.0165 0.2205)
+(-0.0060 -0.0135 0.2205)
+(-0.0030 -0.0135 0.2205)
+(0.0000 -0.0135 0.2205)
+(0.0030 -0.0135 0.2205)
+(0.0060 -0.0135 0.2205)
+(-0.0060 -0.0105 0.2205)
+(-0.0030 -0.0105 0.2205)
+(0.0000 -0.0105 0.2205)
+(0.0030 -0.0105 0.2205)
+(0.0060 -0.0105 0.2205)
+(-0.0060 -0.0075 0.2205)
+(-0.0030 -0.0075 0.2205)
+(0.0000 -0.0075 0.2205)
+(0.0030 -0.0075 0.2205)
+(0.0060 -0.0075 0.2205)
+(-0.0060 -0.0045 0.2205)
+(-0.0030 -0.0045 0.2205)
+(0.0000 -0.0045 0.2205)
+(0.0030 -0.0045 0.2205)
+(0.0060 -0.0045 0.2205)
+(-0.0060 -0.0015 0.2205)
+(-0.0030 -0.0015 0.2205)
+(0.0000 -0.0015 0.2205)
+(0.0030 -0.0015 0.2205)
+(0.0060 -0.0015 0.2205)
+(-0.0060 0.0015 0.2205)
+(-0.0030 0.0015 0.2205)
+(0.0000 0.0015 0.2205)
+(0.0030 0.0015 0.2205)
+(0.0060 0.0015 0.2205)
+(-0.0060 0.0045 0.2205)
+(-0.0030 0.0045 0.2205)
+(0.0000 0.0045 0.2205)
+(0.0030 0.0045 0.2205)
+(0.0060 0.0045 0.2205)
+(-0.0060 0.0075 0.2205)
+(-0.0030 0.0075 0.2205)
+(0.0000 0.0075 0.2205)
+(0.0030 0.0075 0.2205)
+(0.0060 0.0075 0.2205)
+(-0.0060 0.0105 0.2205)
+(-0.0030 0.0105 0.2205)
+(0.0000 0.0105 0.2205)
+(0.0030 0.0105 0.2205)
+(0.0060 0.0105 0.2205)
+(-0.0060 0.0135 0.2205)
+(-0.0030 0.0135 0.2205)
+(0.0000 0.0135 0.2205)
+(0.0030 0.0135 0.2205)
+(0.0060 0.0135 0.2205)
+(-0.0060 0.0165 0.2205)
+(-0.0030 0.0165 0.2205)
+(0.0000 0.0165 0.2205)
+(0.0030 0.0165 0.2205)
+(0.0060 0.0165 0.2205)
+(-0.0060 0.0195 0.2205)
+(-0.0030 0.0195 0.2205)
+(0.0000 0.0195 0.2205)
+(0.0030 0.0195 0.2205)
+(0.0060 0.0195 0.2205)
+(-0.0060 0.0225 0.2205)
+(-0.0030 0.0225 0.2205)
+(0.0000 0.0225 0.2205)
+(0.0030 0.0225 0.2205)
+(0.0060 0.0225 0.2205)
+(-0.0060 0.0255 0.2205)
+(-0.0030 0.0255 0.2205)
+(0.0000 0.0255 0.2205)
+(0.0030 0.0255 0.2205)
+(0.0060 0.0255 0.2205)
+(-0.0060 0.0285 0.2205)
+(-0.0030 0.0285 0.2205)
+(0.0000 0.0285 0.2205)
+(0.0030 0.0285 0.2205)
+(0.0060 0.0285 0.2205)
+(-0.0060 0.0315 0.2205)
+(-0.0030 0.0315 0.2205)
+(0.0000 0.0315 0.2205)
+(0.0030 0.0315 0.2205)
+(0.0060 0.0315 0.2205)
+(-0.0060 0.0345 0.2205)
+(-0.0030 0.0345 0.2205)
+(0.0000 0.0345 0.2205)
+(0.0030 0.0345 0.2205)
+(0.0060 0.0345 0.2205)
+(-0.0060 0.0375 0.2205)
+(-0.0030 0.0375 0.2205)
+(0.0000 0.0375 0.2205)
+(0.0030 0.0375 0.2205)
+(0.0060 0.0375 0.2205)
+(-0.0060 0.0405 0.2205)
+(-0.0030 0.0405 0.2205)
+(0.0000 0.0405 0.2205)
+(0.0030 0.0405 0.2205)
+(0.0060 0.0405 0.2205)
+(-0.0060 0.0435 0.2205)
+(-0.0030 0.0435 0.2205)
+(0.0000 0.0435 0.2205)
+(0.0030 0.0435 0.2205)
+(0.0060 0.0435 0.2205)
+(-0.0060 0.0465 0.2205)
+(-0.0030 0.0465 0.2205)
+(0.0000 0.0465 0.2205)
+(0.0030 0.0465 0.2205)
+(0.0060 0.0465 0.2205)
+(-0.0060 0.0495 0.2205)
+(-0.0030 0.0495 0.2205)
+(0.0000 0.0495 0.2205)
+(0.0030 0.0495 0.2205)
+(0.0060 0.0495 0.2205)
+(-0.0060 0.0525 0.2205)
+(-0.0030 0.0525 0.2205)
+(0.0000 0.0525 0.2205)
+(0.0030 0.0525 0.2205)
+(0.0060 0.0525 0.2205)
+(-0.0060 0.0555 0.2205)
+(-0.0030 0.0555 0.2205)
+(0.0000 0.0555 0.2205)
+(0.0030 0.0555 0.2205)
+(0.0060 0.0555 0.2205)
+(-0.0060 0.0585 0.2205)
+(-0.0030 0.0585 0.2205)
+(0.0000 0.0585 0.2205)
+(0.0030 0.0585 0.2205)
+(0.0060 0.0585 0.2205)
+(-0.0060 0.0615 0.2205)
+(-0.0030 0.0615 0.2205)
+(0.0000 0.0615 0.2205)
+(0.0030 0.0615 0.2205)
+(0.0060 0.0615 0.2205)
+(-0.0060 0.0645 0.2205)
+(-0.0030 0.0645 0.2205)
+(0.0000 0.0645 0.2205)
+(0.0030 0.0645 0.2205)
+(0.0060 0.0645 0.2205)
+(-0.0060 0.0675 0.2205)
+(-0.0030 0.0675 0.2205)
+(0.0000 0.0675 0.2205)
+(0.0030 0.0675 0.2205)
+(0.0060 0.0675 0.2205)
+(-0.0060 0.0705 0.2205)
+(-0.0030 0.0705 0.2205)
+(0.0000 0.0705 0.2205)
+(0.0030 0.0705 0.2205)
+(0.0060 0.0705 0.2205)
+(-0.0060 0.0735 0.2205)
+(-0.0030 0.0735 0.2205)
+(0.0000 0.0735 0.2205)
+(0.0030 0.0735 0.2205)
+(0.0060 0.0735 0.2205)
+(-0.0060 -0.0735 0.2235)
+(-0.0030 -0.0735 0.2235)
+(0.0000 -0.0735 0.2235)
+(0.0030 -0.0735 0.2235)
+(0.0060 -0.0735 0.2235)
+(-0.0060 -0.0705 0.2235)
+(-0.0030 -0.0705 0.2235)
+(0.0000 -0.0705 0.2235)
+(0.0030 -0.0705 0.2235)
+(0.0060 -0.0705 0.2235)
+(-0.0060 -0.0675 0.2235)
+(-0.0030 -0.0675 0.2235)
+(0.0000 -0.0675 0.2235)
+(0.0030 -0.0675 0.2235)
+(0.0060 -0.0675 0.2235)
+(-0.0060 -0.0645 0.2235)
+(-0.0030 -0.0645 0.2235)
+(0.0000 -0.0645 0.2235)
+(0.0030 -0.0645 0.2235)
+(0.0060 -0.0645 0.2235)
+(-0.0060 -0.0615 0.2235)
+(-0.0030 -0.0615 0.2235)
+(0.0000 -0.0615 0.2235)
+(0.0030 -0.0615 0.2235)
+(0.0060 -0.0615 0.2235)
+(-0.0060 -0.0585 0.2235)
+(-0.0030 -0.0585 0.2235)
+(0.0000 -0.0585 0.2235)
+(0.0030 -0.0585 0.2235)
+(0.0060 -0.0585 0.2235)
+(-0.0060 -0.0555 0.2235)
+(-0.0030 -0.0555 0.2235)
+(0.0000 -0.0555 0.2235)
+(0.0030 -0.0555 0.2235)
+(0.0060 -0.0555 0.2235)
+(-0.0060 -0.0525 0.2235)
+(-0.0030 -0.0525 0.2235)
+(0.0000 -0.0525 0.2235)
+(0.0030 -0.0525 0.2235)
+(0.0060 -0.0525 0.2235)
+(-0.0060 -0.0495 0.2235)
+(-0.0030 -0.0495 0.2235)
+(0.0000 -0.0495 0.2235)
+(0.0030 -0.0495 0.2235)
+(0.0060 -0.0495 0.2235)
+(-0.0060 -0.0465 0.2235)
+(-0.0030 -0.0465 0.2235)
+(0.0000 -0.0465 0.2235)
+(0.0030 -0.0465 0.2235)
+(0.0060 -0.0465 0.2235)
+(-0.0060 -0.0435 0.2235)
+(-0.0030 -0.0435 0.2235)
+(0.0000 -0.0435 0.2235)
+(0.0030 -0.0435 0.2235)
+(0.0060 -0.0435 0.2235)
+(-0.0060 -0.0405 0.2235)
+(-0.0030 -0.0405 0.2235)
+(0.0000 -0.0405 0.2235)
+(0.0030 -0.0405 0.2235)
+(0.0060 -0.0405 0.2235)
+(-0.0060 -0.0375 0.2235)
+(-0.0030 -0.0375 0.2235)
+(0.0000 -0.0375 0.2235)
+(0.0030 -0.0375 0.2235)
+(0.0060 -0.0375 0.2235)
+(-0.0060 -0.0345 0.2235)
+(-0.0030 -0.0345 0.2235)
+(0.0000 -0.0345 0.2235)
+(0.0030 -0.0345 0.2235)
+(0.0060 -0.0345 0.2235)
+(-0.0060 -0.0315 0.2235)
+(-0.0030 -0.0315 0.2235)
+(0.0000 -0.0315 0.2235)
+(0.0030 -0.0315 0.2235)
+(0.0060 -0.0315 0.2235)
+(-0.0060 -0.0285 0.2235)
+(-0.0030 -0.0285 0.2235)
+(0.0000 -0.0285 0.2235)
+(0.0030 -0.0285 0.2235)
+(0.0060 -0.0285 0.2235)
+(-0.0060 -0.0255 0.2235)
+(-0.0030 -0.0255 0.2235)
+(0.0000 -0.0255 0.2235)
+(0.0030 -0.0255 0.2235)
+(0.0060 -0.0255 0.2235)
+(-0.0060 -0.0225 0.2235)
+(-0.0030 -0.0225 0.2235)
+(0.0000 -0.0225 0.2235)
+(0.0030 -0.0225 0.2235)
+(0.0060 -0.0225 0.2235)
+(-0.0060 -0.0195 0.2235)
+(-0.0030 -0.0195 0.2235)
+(0.0000 -0.0195 0.2235)
+(0.0030 -0.0195 0.2235)
+(0.0060 -0.0195 0.2235)
+(-0.0060 -0.0165 0.2235)
+(-0.0030 -0.0165 0.2235)
+(0.0000 -0.0165 0.2235)
+(0.0030 -0.0165 0.2235)
+(0.0060 -0.0165 0.2235)
+(-0.0060 -0.0135 0.2235)
+(-0.0030 -0.0135 0.2235)
+(0.0000 -0.0135 0.2235)
+(0.0030 -0.0135 0.2235)
+(0.0060 -0.0135 0.2235)
+(-0.0060 -0.0105 0.2235)
+(-0.0030 -0.0105 0.2235)
+(0.0000 -0.0105 0.2235)
+(0.0030 -0.0105 0.2235)
+(0.0060 -0.0105 0.2235)
+(-0.0060 -0.0075 0.2235)
+(-0.0030 -0.0075 0.2235)
+(0.0000 -0.0075 0.2235)
+(0.0030 -0.0075 0.2235)
+(0.0060 -0.0075 0.2235)
+(-0.0060 -0.0045 0.2235)
+(-0.0030 -0.0045 0.2235)
+(0.0000 -0.0045 0.2235)
+(0.0030 -0.0045 0.2235)
+(0.0060 -0.0045 0.2235)
+(-0.0060 -0.0015 0.2235)
+(-0.0030 -0.0015 0.2235)
+(0.0000 -0.0015 0.2235)
+(0.0030 -0.0015 0.2235)
+(0.0060 -0.0015 0.2235)
+(-0.0060 0.0015 0.2235)
+(-0.0030 0.0015 0.2235)
+(0.0000 0.0015 0.2235)
+(0.0030 0.0015 0.2235)
+(0.0060 0.0015 0.2235)
+(-0.0060 0.0045 0.2235)
+(-0.0030 0.0045 0.2235)
+(0.0000 0.0045 0.2235)
+(0.0030 0.0045 0.2235)
+(0.0060 0.0045 0.2235)
+(-0.0060 0.0075 0.2235)
+(-0.0030 0.0075 0.2235)
+(0.0000 0.0075 0.2235)
+(0.0030 0.0075 0.2235)
+(0.0060 0.0075 0.2235)
+(-0.0060 0.0105 0.2235)
+(-0.0030 0.0105 0.2235)
+(0.0000 0.0105 0.2235)
+(0.0030 0.0105 0.2235)
+(0.0060 0.0105 0.2235)
+(-0.0060 0.0135 0.2235)
+(-0.0030 0.0135 0.2235)
+(0.0000 0.0135 0.2235)
+(0.0030 0.0135 0.2235)
+(0.0060 0.0135 0.2235)
+(-0.0060 0.0165 0.2235)
+(-0.0030 0.0165 0.2235)
+(0.0000 0.0165 0.2235)
+(0.0030 0.0165 0.2235)
+(0.0060 0.0165 0.2235)
+(-0.0060 0.0195 0.2235)
+(-0.0030 0.0195 0.2235)
+(0.0000 0.0195 0.2235)
+(0.0030 0.0195 0.2235)
+(0.0060 0.0195 0.2235)
+(-0.0060 0.0225 0.2235)
+(-0.0030 0.0225 0.2235)
+(0.0000 0.0225 0.2235)
+(0.0030 0.0225 0.2235)
+(0.0060 0.0225 0.2235)
+(-0.0060 0.0255 0.2235)
+(-0.0030 0.0255 0.2235)
+(0.0000 0.0255 0.2235)
+(0.0030 0.0255 0.2235)
+(0.0060 0.0255 0.2235)
+(-0.0060 0.0285 0.2235)
+(-0.0030 0.0285 0.2235)
+(0.0000 0.0285 0.2235)
+(0.0030 0.0285 0.2235)
+(0.0060 0.0285 0.2235)
+(-0.0060 0.0315 0.2235)
+(-0.0030 0.0315 0.2235)
+(0.0000 0.0315 0.2235)
+(0.0030 0.0315 0.2235)
+(0.0060 0.0315 0.2235)
+(-0.0060 0.0345 0.2235)
+(-0.0030 0.0345 0.2235)
+(0.0000 0.0345 0.2235)
+(0.0030 0.0345 0.2235)
+(0.0060 0.0345 0.2235)
+(-0.0060 0.0375 0.2235)
+(-0.0030 0.0375 0.2235)
+(0.0000 0.0375 0.2235)
+(0.0030 0.0375 0.2235)
+(0.0060 0.0375 0.2235)
+(-0.0060 0.0405 0.2235)
+(-0.0030 0.0405 0.2235)
+(0.0000 0.0405 0.2235)
+(0.0030 0.0405 0.2235)
+(0.0060 0.0405 0.2235)
+(-0.0060 0.0435 0.2235)
+(-0.0030 0.0435 0.2235)
+(0.0000 0.0435 0.2235)
+(0.0030 0.0435 0.2235)
+(0.0060 0.0435 0.2235)
+(-0.0060 0.0465 0.2235)
+(-0.0030 0.0465 0.2235)
+(0.0000 0.0465 0.2235)
+(0.0030 0.0465 0.2235)
+(0.0060 0.0465 0.2235)
+(-0.0060 0.0495 0.2235)
+(-0.0030 0.0495 0.2235)
+(0.0000 0.0495 0.2235)
+(0.0030 0.0495 0.2235)
+(0.0060 0.0495 0.2235)
+(-0.0060 0.0525 0.2235)
+(-0.0030 0.0525 0.2235)
+(0.0000 0.0525 0.2235)
+(0.0030 0.0525 0.2235)
+(0.0060 0.0525 0.2235)
+(-0.0060 0.0555 0.2235)
+(-0.0030 0.0555 0.2235)
+(0.0000 0.0555 0.2235)
+(0.0030 0.0555 0.2235)
+(0.0060 0.0555 0.2235)
+(-0.0060 0.0585 0.2235)
+(-0.0030 0.0585 0.2235)
+(0.0000 0.0585 0.2235)
+(0.0030 0.0585 0.2235)
+(0.0060 0.0585 0.2235)
+(-0.0060 0.0615 0.2235)
+(-0.0030 0.0615 0.2235)
+(0.0000 0.0615 0.2235)
+(0.0030 0.0615 0.2235)
+(0.0060 0.0615 0.2235)
+(-0.0060 0.0645 0.2235)
+(-0.0030 0.0645 0.2235)
+(0.0000 0.0645 0.2235)
+(0.0030 0.0645 0.2235)
+(0.0060 0.0645 0.2235)
+(-0.0060 0.0675 0.2235)
+(-0.0030 0.0675 0.2235)
+(0.0000 0.0675 0.2235)
+(0.0030 0.0675 0.2235)
+(0.0060 0.0675 0.2235)
+(-0.0060 0.0705 0.2235)
+(-0.0030 0.0705 0.2235)
+(0.0000 0.0705 0.2235)
+(0.0030 0.0705 0.2235)
+(0.0060 0.0705 0.2235)
+(-0.0060 0.0735 0.2235)
+(-0.0030 0.0735 0.2235)
+(0.0000 0.0735 0.2235)
+(0.0030 0.0735 0.2235)
+(0.0060 0.0735 0.2235)
+(-0.0060 -0.0735 0.2265)
+(-0.0030 -0.0735 0.2265)
+(0.0000 -0.0735 0.2265)
+(0.0030 -0.0735 0.2265)
+(0.0060 -0.0735 0.2265)
+(-0.0060 -0.0705 0.2265)
+(-0.0030 -0.0705 0.2265)
+(0.0000 -0.0705 0.2265)
+(0.0030 -0.0705 0.2265)
+(0.0060 -0.0705 0.2265)
+(-0.0060 -0.0675 0.2265)
+(-0.0030 -0.0675 0.2265)
+(0.0000 -0.0675 0.2265)
+(0.0030 -0.0675 0.2265)
+(0.0060 -0.0675 0.2265)
+(-0.0060 -0.0645 0.2265)
+(-0.0030 -0.0645 0.2265)
+(0.0000 -0.0645 0.2265)
+(0.0030 -0.0645 0.2265)
+(0.0060 -0.0645 0.2265)
+(-0.0060 -0.0615 0.2265)
+(-0.0030 -0.0615 0.2265)
+(0.0000 -0.0615 0.2265)
+(0.0030 -0.0615 0.2265)
+(0.0060 -0.0615 0.2265)
+(-0.0060 -0.0585 0.2265)
+(-0.0030 -0.0585 0.2265)
+(0.0000 -0.0585 0.2265)
+(0.0030 -0.0585 0.2265)
+(0.0060 -0.0585 0.2265)
+(-0.0060 -0.0555 0.2265)
+(-0.0030 -0.0555 0.2265)
+(0.0000 -0.0555 0.2265)
+(0.0030 -0.0555 0.2265)
+(0.0060 -0.0555 0.2265)
+(-0.0060 -0.0525 0.2265)
+(-0.0030 -0.0525 0.2265)
+(0.0000 -0.0525 0.2265)
+(0.0030 -0.0525 0.2265)
+(0.0060 -0.0525 0.2265)
+(-0.0060 -0.0495 0.2265)
+(-0.0030 -0.0495 0.2265)
+(0.0000 -0.0495 0.2265)
+(0.0030 -0.0495 0.2265)
+(0.0060 -0.0495 0.2265)
+(-0.0060 -0.0465 0.2265)
+(-0.0030 -0.0465 0.2265)
+(0.0000 -0.0465 0.2265)
+(0.0030 -0.0465 0.2265)
+(0.0060 -0.0465 0.2265)
+(-0.0060 -0.0435 0.2265)
+(-0.0030 -0.0435 0.2265)
+(0.0000 -0.0435 0.2265)
+(0.0030 -0.0435 0.2265)
+(0.0060 -0.0435 0.2265)
+(-0.0060 -0.0405 0.2265)
+(-0.0030 -0.0405 0.2265)
+(0.0000 -0.0405 0.2265)
+(0.0030 -0.0405 0.2265)
+(0.0060 -0.0405 0.2265)
+(-0.0060 -0.0375 0.2265)
+(-0.0030 -0.0375 0.2265)
+(0.0000 -0.0375 0.2265)
+(0.0030 -0.0375 0.2265)
+(0.0060 -0.0375 0.2265)
+(-0.0060 -0.0345 0.2265)
+(-0.0030 -0.0345 0.2265)
+(0.0000 -0.0345 0.2265)
+(0.0030 -0.0345 0.2265)
+(0.0060 -0.0345 0.2265)
+(-0.0060 -0.0315 0.2265)
+(-0.0030 -0.0315 0.2265)
+(0.0000 -0.0315 0.2265)
+(0.0030 -0.0315 0.2265)
+(0.0060 -0.0315 0.2265)
+(-0.0060 -0.0285 0.2265)
+(-0.0030 -0.0285 0.2265)
+(0.0000 -0.0285 0.2265)
+(0.0030 -0.0285 0.2265)
+(0.0060 -0.0285 0.2265)
+(-0.0060 -0.0255 0.2265)
+(-0.0030 -0.0255 0.2265)
+(0.0000 -0.0255 0.2265)
+(0.0030 -0.0255 0.2265)
+(0.0060 -0.0255 0.2265)
+(-0.0060 -0.0225 0.2265)
+(-0.0030 -0.0225 0.2265)
+(0.0000 -0.0225 0.2265)
+(0.0030 -0.0225 0.2265)
+(0.0060 -0.0225 0.2265)
+(-0.0060 -0.0195 0.2265)
+(-0.0030 -0.0195 0.2265)
+(0.0000 -0.0195 0.2265)
+(0.0030 -0.0195 0.2265)
+(0.0060 -0.0195 0.2265)
+(-0.0060 -0.0165 0.2265)
+(-0.0030 -0.0165 0.2265)
+(0.0000 -0.0165 0.2265)
+(0.0030 -0.0165 0.2265)
+(0.0060 -0.0165 0.2265)
+(-0.0060 -0.0135 0.2265)
+(-0.0030 -0.0135 0.2265)
+(0.0000 -0.0135 0.2265)
+(0.0030 -0.0135 0.2265)
+(0.0060 -0.0135 0.2265)
+(-0.0060 -0.0105 0.2265)
+(-0.0030 -0.0105 0.2265)
+(0.0000 -0.0105 0.2265)
+(0.0030 -0.0105 0.2265)
+(0.0060 -0.0105 0.2265)
+(-0.0060 -0.0075 0.2265)
+(-0.0030 -0.0075 0.2265)
+(0.0000 -0.0075 0.2265)
+(0.0030 -0.0075 0.2265)
+(0.0060 -0.0075 0.2265)
+(-0.0060 -0.0045 0.2265)
+(-0.0030 -0.0045 0.2265)
+(0.0000 -0.0045 0.2265)
+(0.0030 -0.0045 0.2265)
+(0.0060 -0.0045 0.2265)
+(-0.0060 -0.0015 0.2265)
+(-0.0030 -0.0015 0.2265)
+(0.0000 -0.0015 0.2265)
+(0.0030 -0.0015 0.2265)
+(0.0060 -0.0015 0.2265)
+(-0.0060 0.0015 0.2265)
+(-0.0030 0.0015 0.2265)
+(0.0000 0.0015 0.2265)
+(0.0030 0.0015 0.2265)
+(0.0060 0.0015 0.2265)
+(-0.0060 0.0045 0.2265)
+(-0.0030 0.0045 0.2265)
+(0.0000 0.0045 0.2265)
+(0.0030 0.0045 0.2265)
+(0.0060 0.0045 0.2265)
+(-0.0060 0.0075 0.2265)
+(-0.0030 0.0075 0.2265)
+(0.0000 0.0075 0.2265)
+(0.0030 0.0075 0.2265)
+(0.0060 0.0075 0.2265)
+(-0.0060 0.0105 0.2265)
+(-0.0030 0.0105 0.2265)
+(0.0000 0.0105 0.2265)
+(0.0030 0.0105 0.2265)
+(0.0060 0.0105 0.2265)
+(-0.0060 0.0135 0.2265)
+(-0.0030 0.0135 0.2265)
+(0.0000 0.0135 0.2265)
+(0.0030 0.0135 0.2265)
+(0.0060 0.0135 0.2265)
+(-0.0060 0.0165 0.2265)
+(-0.0030 0.0165 0.2265)
+(0.0000 0.0165 0.2265)
+(0.0030 0.0165 0.2265)
+(0.0060 0.0165 0.2265)
+(-0.0060 0.0195 0.2265)
+(-0.0030 0.0195 0.2265)
+(0.0000 0.0195 0.2265)
+(0.0030 0.0195 0.2265)
+(0.0060 0.0195 0.2265)
+(-0.0060 0.0225 0.2265)
+(-0.0030 0.0225 0.2265)
+(0.0000 0.0225 0.2265)
+(0.0030 0.0225 0.2265)
+(0.0060 0.0225 0.2265)
+(-0.0060 0.0255 0.2265)
+(-0.0030 0.0255 0.2265)
+(0.0000 0.0255 0.2265)
+(0.0030 0.0255 0.2265)
+(0.0060 0.0255 0.2265)
+(-0.0060 0.0285 0.2265)
+(-0.0030 0.0285 0.2265)
+(0.0000 0.0285 0.2265)
+(0.0030 0.0285 0.2265)
+(0.0060 0.0285 0.2265)
+(-0.0060 0.0315 0.2265)
+(-0.0030 0.0315 0.2265)
+(0.0000 0.0315 0.2265)
+(0.0030 0.0315 0.2265)
+(0.0060 0.0315 0.2265)
+(-0.0060 0.0345 0.2265)
+(-0.0030 0.0345 0.2265)
+(0.0000 0.0345 0.2265)
+(0.0030 0.0345 0.2265)
+(0.0060 0.0345 0.2265)
+(-0.0060 0.0375 0.2265)
+(-0.0030 0.0375 0.2265)
+(0.0000 0.0375 0.2265)
+(0.0030 0.0375 0.2265)
+(0.0060 0.0375 0.2265)
+(-0.0060 0.0405 0.2265)
+(-0.0030 0.0405 0.2265)
+(0.0000 0.0405 0.2265)
+(0.0030 0.0405 0.2265)
+(0.0060 0.0405 0.2265)
+(-0.0060 0.0435 0.2265)
+(-0.0030 0.0435 0.2265)
+(0.0000 0.0435 0.2265)
+(0.0030 0.0435 0.2265)
+(0.0060 0.0435 0.2265)
+(-0.0060 0.0465 0.2265)
+(-0.0030 0.0465 0.2265)
+(0.0000 0.0465 0.2265)
+(0.0030 0.0465 0.2265)
+(0.0060 0.0465 0.2265)
+(-0.0060 0.0495 0.2265)
+(-0.0030 0.0495 0.2265)
+(0.0000 0.0495 0.2265)
+(0.0030 0.0495 0.2265)
+(0.0060 0.0495 0.2265)
+(-0.0060 0.0525 0.2265)
+(-0.0030 0.0525 0.2265)
+(0.0000 0.0525 0.2265)
+(0.0030 0.0525 0.2265)
+(0.0060 0.0525 0.2265)
+(-0.0060 0.0555 0.2265)
+(-0.0030 0.0555 0.2265)
+(0.0000 0.0555 0.2265)
+(0.0030 0.0555 0.2265)
+(0.0060 0.0555 0.2265)
+(-0.0060 0.0585 0.2265)
+(-0.0030 0.0585 0.2265)
+(0.0000 0.0585 0.2265)
+(0.0030 0.0585 0.2265)
+(0.0060 0.0585 0.2265)
+(-0.0060 0.0615 0.2265)
+(-0.0030 0.0615 0.2265)
+(0.0000 0.0615 0.2265)
+(0.0030 0.0615 0.2265)
+(0.0060 0.0615 0.2265)
+(-0.0060 0.0645 0.2265)
+(-0.0030 0.0645 0.2265)
+(0.0000 0.0645 0.2265)
+(0.0030 0.0645 0.2265)
+(0.0060 0.0645 0.2265)
+(-0.0060 0.0675 0.2265)
+(-0.0030 0.0675 0.2265)
+(0.0000 0.0675 0.2265)
+(0.0030 0.0675 0.2265)
+(0.0060 0.0675 0.2265)
+(-0.0060 0.0705 0.2265)
+(-0.0030 0.0705 0.2265)
+(0.0000 0.0705 0.2265)
+(0.0030 0.0705 0.2265)
+(0.0060 0.0705 0.2265)
+(-0.0060 0.0735 0.2265)
+(-0.0030 0.0735 0.2265)
+(0.0000 0.0735 0.2265)
+(0.0030 0.0735 0.2265)
+(0.0060 0.0735 0.2265)
+(-0.0060 -0.0735 0.2295)
+(-0.0030 -0.0735 0.2295)
+(0.0000 -0.0735 0.2295)
+(0.0030 -0.0735 0.2295)
+(0.0060 -0.0735 0.2295)
+(-0.0060 -0.0705 0.2295)
+(-0.0030 -0.0705 0.2295)
+(0.0000 -0.0705 0.2295)
+(0.0030 -0.0705 0.2295)
+(0.0060 -0.0705 0.2295)
+(-0.0060 -0.0675 0.2295)
+(-0.0030 -0.0675 0.2295)
+(0.0000 -0.0675 0.2295)
+(0.0030 -0.0675 0.2295)
+(0.0060 -0.0675 0.2295)
+(-0.0060 -0.0645 0.2295)
+(-0.0030 -0.0645 0.2295)
+(0.0000 -0.0645 0.2295)
+(0.0030 -0.0645 0.2295)
+(0.0060 -0.0645 0.2295)
+(-0.0060 -0.0615 0.2295)
+(-0.0030 -0.0615 0.2295)
+(0.0000 -0.0615 0.2295)
+(0.0030 -0.0615 0.2295)
+(0.0060 -0.0615 0.2295)
+(-0.0060 -0.0585 0.2295)
+(-0.0030 -0.0585 0.2295)
+(0.0000 -0.0585 0.2295)
+(0.0030 -0.0585 0.2295)
+(0.0060 -0.0585 0.2295)
+(-0.0060 -0.0555 0.2295)
+(-0.0030 -0.0555 0.2295)
+(0.0000 -0.0555 0.2295)
+(0.0030 -0.0555 0.2295)
+(0.0060 -0.0555 0.2295)
+(-0.0060 -0.0525 0.2295)
+(-0.0030 -0.0525 0.2295)
+(0.0000 -0.0525 0.2295)
+(0.0030 -0.0525 0.2295)
+(0.0060 -0.0525 0.2295)
+(-0.0060 -0.0495 0.2295)
+(-0.0030 -0.0495 0.2295)
+(0.0000 -0.0495 0.2295)
+(0.0030 -0.0495 0.2295)
+(0.0060 -0.0495 0.2295)
+(-0.0060 -0.0465 0.2295)
+(-0.0030 -0.0465 0.2295)
+(0.0000 -0.0465 0.2295)
+(0.0030 -0.0465 0.2295)
+(0.0060 -0.0465 0.2295)
+(-0.0060 -0.0435 0.2295)
+(-0.0030 -0.0435 0.2295)
+(0.0000 -0.0435 0.2295)
+(0.0030 -0.0435 0.2295)
+(0.0060 -0.0435 0.2295)
+(-0.0060 -0.0405 0.2295)
+(-0.0030 -0.0405 0.2295)
+(0.0000 -0.0405 0.2295)
+(0.0030 -0.0405 0.2295)
+(0.0060 -0.0405 0.2295)
+(-0.0060 -0.0375 0.2295)
+(-0.0030 -0.0375 0.2295)
+(0.0000 -0.0375 0.2295)
+(0.0030 -0.0375 0.2295)
+(0.0060 -0.0375 0.2295)
+(-0.0060 -0.0345 0.2295)
+(-0.0030 -0.0345 0.2295)
+(0.0000 -0.0345 0.2295)
+(0.0030 -0.0345 0.2295)
+(0.0060 -0.0345 0.2295)
+(-0.0060 -0.0315 0.2295)
+(-0.0030 -0.0315 0.2295)
+(0.0000 -0.0315 0.2295)
+(0.0030 -0.0315 0.2295)
+(0.0060 -0.0315 0.2295)
+(-0.0060 -0.0285 0.2295)
+(-0.0030 -0.0285 0.2295)
+(0.0000 -0.0285 0.2295)
+(0.0030 -0.0285 0.2295)
+(0.0060 -0.0285 0.2295)
+(-0.0060 -0.0255 0.2295)
+(-0.0030 -0.0255 0.2295)
+(0.0000 -0.0255 0.2295)
+(0.0030 -0.0255 0.2295)
+(0.0060 -0.0255 0.2295)
+(-0.0060 -0.0225 0.2295)
+(-0.0030 -0.0225 0.2295)
+(0.0000 -0.0225 0.2295)
+(0.0030 -0.0225 0.2295)
+(0.0060 -0.0225 0.2295)
+(-0.0060 -0.0195 0.2295)
+(-0.0030 -0.0195 0.2295)
+(0.0000 -0.0195 0.2295)
+(0.0030 -0.0195 0.2295)
+(0.0060 -0.0195 0.2295)
+(-0.0060 -0.0165 0.2295)
+(-0.0030 -0.0165 0.2295)
+(0.0000 -0.0165 0.2295)
+(0.0030 -0.0165 0.2295)
+(0.0060 -0.0165 0.2295)
+(-0.0060 -0.0135 0.2295)
+(-0.0030 -0.0135 0.2295)
+(0.0000 -0.0135 0.2295)
+(0.0030 -0.0135 0.2295)
+(0.0060 -0.0135 0.2295)
+(-0.0060 -0.0105 0.2295)
+(-0.0030 -0.0105 0.2295)
+(0.0000 -0.0105 0.2295)
+(0.0030 -0.0105 0.2295)
+(0.0060 -0.0105 0.2295)
+(-0.0060 -0.0075 0.2295)
+(-0.0030 -0.0075 0.2295)
+(0.0000 -0.0075 0.2295)
+(0.0030 -0.0075 0.2295)
+(0.0060 -0.0075 0.2295)
+(-0.0060 -0.0045 0.2295)
+(-0.0030 -0.0045 0.2295)
+(0.0000 -0.0045 0.2295)
+(0.0030 -0.0045 0.2295)
+(0.0060 -0.0045 0.2295)
+(-0.0060 -0.0015 0.2295)
+(-0.0030 -0.0015 0.2295)
+(0.0000 -0.0015 0.2295)
+(0.0030 -0.0015 0.2295)
+(0.0060 -0.0015 0.2295)
+(-0.0060 0.0015 0.2295)
+(-0.0030 0.0015 0.2295)
+(0.0000 0.0015 0.2295)
+(0.0030 0.0015 0.2295)
+(0.0060 0.0015 0.2295)
+(-0.0060 0.0045 0.2295)
+(-0.0030 0.0045 0.2295)
+(0.0000 0.0045 0.2295)
+(0.0030 0.0045 0.2295)
+(0.0060 0.0045 0.2295)
+(-0.0060 0.0075 0.2295)
+(-0.0030 0.0075 0.2295)
+(0.0000 0.0075 0.2295)
+(0.0030 0.0075 0.2295)
+(0.0060 0.0075 0.2295)
+(-0.0060 0.0105 0.2295)
+(-0.0030 0.0105 0.2295)
+(0.0000 0.0105 0.2295)
+(0.0030 0.0105 0.2295)
+(0.0060 0.0105 0.2295)
+(-0.0060 0.0135 0.2295)
+(-0.0030 0.0135 0.2295)
+(0.0000 0.0135 0.2295)
+(0.0030 0.0135 0.2295)
+(0.0060 0.0135 0.2295)
+(-0.0060 0.0165 0.2295)
+(-0.0030 0.0165 0.2295)
+(0.0000 0.0165 0.2295)
+(0.0030 0.0165 0.2295)
+(0.0060 0.0165 0.2295)
+(-0.0060 0.0195 0.2295)
+(-0.0030 0.0195 0.2295)
+(0.0000 0.0195 0.2295)
+(0.0030 0.0195 0.2295)
+(0.0060 0.0195 0.2295)
+(-0.0060 0.0225 0.2295)
+(-0.0030 0.0225 0.2295)
+(0.0000 0.0225 0.2295)
+(0.0030 0.0225 0.2295)
+(0.0060 0.0225 0.2295)
+(-0.0060 0.0255 0.2295)
+(-0.0030 0.0255 0.2295)
+(0.0000 0.0255 0.2295)
+(0.0030 0.0255 0.2295)
+(0.0060 0.0255 0.2295)
+(-0.0060 0.0285 0.2295)
+(-0.0030 0.0285 0.2295)
+(0.0000 0.0285 0.2295)
+(0.0030 0.0285 0.2295)
+(0.0060 0.0285 0.2295)
+(-0.0060 0.0315 0.2295)
+(-0.0030 0.0315 0.2295)
+(0.0000 0.0315 0.2295)
+(0.0030 0.0315 0.2295)
+(0.0060 0.0315 0.2295)
+(-0.0060 0.0345 0.2295)
+(-0.0030 0.0345 0.2295)
+(0.0000 0.0345 0.2295)
+(0.0030 0.0345 0.2295)
+(0.0060 0.0345 0.2295)
+(-0.0060 0.0375 0.2295)
+(-0.0030 0.0375 0.2295)
+(0.0000 0.0375 0.2295)
+(0.0030 0.0375 0.2295)
+(0.0060 0.0375 0.2295)
+(-0.0060 0.0405 0.2295)
+(-0.0030 0.0405 0.2295)
+(0.0000 0.0405 0.2295)
+(0.0030 0.0405 0.2295)
+(0.0060 0.0405 0.2295)
+(-0.0060 0.0435 0.2295)
+(-0.0030 0.0435 0.2295)
+(0.0000 0.0435 0.2295)
+(0.0030 0.0435 0.2295)
+(0.0060 0.0435 0.2295)
+(-0.0060 0.0465 0.2295)
+(-0.0030 0.0465 0.2295)
+(0.0000 0.0465 0.2295)
+(0.0030 0.0465 0.2295)
+(0.0060 0.0465 0.2295)
+(-0.0060 0.0495 0.2295)
+(-0.0030 0.0495 0.2295)
+(0.0000 0.0495 0.2295)
+(0.0030 0.0495 0.2295)
+(0.0060 0.0495 0.2295)
+(-0.0060 0.0525 0.2295)
+(-0.0030 0.0525 0.2295)
+(0.0000 0.0525 0.2295)
+(0.0030 0.0525 0.2295)
+(0.0060 0.0525 0.2295)
+(-0.0060 0.0555 0.2295)
+(-0.0030 0.0555 0.2295)
+(0.0000 0.0555 0.2295)
+(0.0030 0.0555 0.2295)
+(0.0060 0.0555 0.2295)
+(-0.0060 0.0585 0.2295)
+(-0.0030 0.0585 0.2295)
+(0.0000 0.0585 0.2295)
+(0.0030 0.0585 0.2295)
+(0.0060 0.0585 0.2295)
+(-0.0060 0.0615 0.2295)
+(-0.0030 0.0615 0.2295)
+(0.0000 0.0615 0.2295)
+(0.0030 0.0615 0.2295)
+(0.0060 0.0615 0.2295)
+(-0.0060 0.0645 0.2295)
+(-0.0030 0.0645 0.2295)
+(0.0000 0.0645 0.2295)
+(0.0030 0.0645 0.2295)
+(0.0060 0.0645 0.2295)
+(-0.0060 0.0675 0.2295)
+(-0.0030 0.0675 0.2295)
+(0.0000 0.0675 0.2295)
+(0.0030 0.0675 0.2295)
+(0.0060 0.0675 0.2295)
+(-0.0060 0.0705 0.2295)
+(-0.0030 0.0705 0.2295)
+(0.0000 0.0705 0.2295)
+(0.0030 0.0705 0.2295)
+(0.0060 0.0705 0.2295)
+(-0.0060 0.0735 0.2295)
+(-0.0030 0.0735 0.2295)
+(0.0000 0.0735 0.2295)
+(0.0030 0.0735 0.2295)
+(0.0060 0.0735 0.2295)
+(-0.0060 -0.0735 0.2325)
+(-0.0030 -0.0735 0.2325)
+(0.0000 -0.0735 0.2325)
+(0.0030 -0.0735 0.2325)
+(0.0060 -0.0735 0.2325)
+(-0.0060 -0.0705 0.2325)
+(-0.0030 -0.0705 0.2325)
+(0.0000 -0.0705 0.2325)
+(0.0030 -0.0705 0.2325)
+(0.0060 -0.0705 0.2325)
+(-0.0060 -0.0675 0.2325)
+(-0.0030 -0.0675 0.2325)
+(0.0000 -0.0675 0.2325)
+(0.0030 -0.0675 0.2325)
+(0.0060 -0.0675 0.2325)
+(-0.0060 -0.0645 0.2325)
+(-0.0030 -0.0645 0.2325)
+(0.0000 -0.0645 0.2325)
+(0.0030 -0.0645 0.2325)
+(0.0060 -0.0645 0.2325)
+(-0.0060 -0.0615 0.2325)
+(-0.0030 -0.0615 0.2325)
+(0.0000 -0.0615 0.2325)
+(0.0030 -0.0615 0.2325)
+(0.0060 -0.0615 0.2325)
+(-0.0060 -0.0585 0.2325)
+(-0.0030 -0.0585 0.2325)
+(0.0000 -0.0585 0.2325)
+(0.0030 -0.0585 0.2325)
+(0.0060 -0.0585 0.2325)
+(-0.0060 -0.0555 0.2325)
+(-0.0030 -0.0555 0.2325)
+(0.0000 -0.0555 0.2325)
+(0.0030 -0.0555 0.2325)
+(0.0060 -0.0555 0.2325)
+(-0.0060 -0.0525 0.2325)
+(-0.0030 -0.0525 0.2325)
+(0.0000 -0.0525 0.2325)
+(0.0030 -0.0525 0.2325)
+(0.0060 -0.0525 0.2325)
+(-0.0060 -0.0495 0.2325)
+(-0.0030 -0.0495 0.2325)
+(0.0000 -0.0495 0.2325)
+(0.0030 -0.0495 0.2325)
+(0.0060 -0.0495 0.2325)
+(-0.0060 -0.0465 0.2325)
+(-0.0030 -0.0465 0.2325)
+(0.0000 -0.0465 0.2325)
+(0.0030 -0.0465 0.2325)
+(0.0060 -0.0465 0.2325)
+(-0.0060 -0.0435 0.2325)
+(-0.0030 -0.0435 0.2325)
+(0.0000 -0.0435 0.2325)
+(0.0030 -0.0435 0.2325)
+(0.0060 -0.0435 0.2325)
+(-0.0060 -0.0405 0.2325)
+(-0.0030 -0.0405 0.2325)
+(0.0000 -0.0405 0.2325)
+(0.0030 -0.0405 0.2325)
+(0.0060 -0.0405 0.2325)
+(-0.0060 -0.0375 0.2325)
+(-0.0030 -0.0375 0.2325)
+(0.0000 -0.0375 0.2325)
+(0.0030 -0.0375 0.2325)
+(0.0060 -0.0375 0.2325)
+(-0.0060 -0.0345 0.2325)
+(-0.0030 -0.0345 0.2325)
+(0.0000 -0.0345 0.2325)
+(0.0030 -0.0345 0.2325)
+(0.0060 -0.0345 0.2325)
+(-0.0060 -0.0315 0.2325)
+(-0.0030 -0.0315 0.2325)
+(0.0000 -0.0315 0.2325)
+(0.0030 -0.0315 0.2325)
+(0.0060 -0.0315 0.2325)
+(-0.0060 -0.0285 0.2325)
+(-0.0030 -0.0285 0.2325)
+(0.0000 -0.0285 0.2325)
+(0.0030 -0.0285 0.2325)
+(0.0060 -0.0285 0.2325)
+(-0.0060 -0.0255 0.2325)
+(-0.0030 -0.0255 0.2325)
+(0.0000 -0.0255 0.2325)
+(0.0030 -0.0255 0.2325)
+(0.0060 -0.0255 0.2325)
+(-0.0060 -0.0225 0.2325)
+(-0.0030 -0.0225 0.2325)
+(0.0000 -0.0225 0.2325)
+(0.0030 -0.0225 0.2325)
+(0.0060 -0.0225 0.2325)
+(-0.0060 -0.0195 0.2325)
+(-0.0030 -0.0195 0.2325)
+(0.0000 -0.0195 0.2325)
+(0.0030 -0.0195 0.2325)
+(0.0060 -0.0195 0.2325)
+(-0.0060 -0.0165 0.2325)
+(-0.0030 -0.0165 0.2325)
+(0.0000 -0.0165 0.2325)
+(0.0030 -0.0165 0.2325)
+(0.0060 -0.0165 0.2325)
+(-0.0060 -0.0135 0.2325)
+(-0.0030 -0.0135 0.2325)
+(0.0000 -0.0135 0.2325)
+(0.0030 -0.0135 0.2325)
+(0.0060 -0.0135 0.2325)
+(-0.0060 -0.0105 0.2325)
+(-0.0030 -0.0105 0.2325)
+(0.0000 -0.0105 0.2325)
+(0.0030 -0.0105 0.2325)
+(0.0060 -0.0105 0.2325)
+(-0.0060 -0.0075 0.2325)
+(-0.0030 -0.0075 0.2325)
+(0.0000 -0.0075 0.2325)
+(0.0030 -0.0075 0.2325)
+(0.0060 -0.0075 0.2325)
+(-0.0060 -0.0045 0.2325)
+(-0.0030 -0.0045 0.2325)
+(0.0000 -0.0045 0.2325)
+(0.0030 -0.0045 0.2325)
+(0.0060 -0.0045 0.2325)
+(-0.0060 -0.0015 0.2325)
+(-0.0030 -0.0015 0.2325)
+(0.0000 -0.0015 0.2325)
+(0.0030 -0.0015 0.2325)
+(0.0060 -0.0015 0.2325)
+(-0.0060 0.0015 0.2325)
+(-0.0030 0.0015 0.2325)
+(0.0000 0.0015 0.2325)
+(0.0030 0.0015 0.2325)
+(0.0060 0.0015 0.2325)
+(-0.0060 0.0045 0.2325)
+(-0.0030 0.0045 0.2325)
+(0.0000 0.0045 0.2325)
+(0.0030 0.0045 0.2325)
+(0.0060 0.0045 0.2325)
+(-0.0060 0.0075 0.2325)
+(-0.0030 0.0075 0.2325)
+(0.0000 0.0075 0.2325)
+(0.0030 0.0075 0.2325)
+(0.0060 0.0075 0.2325)
+(-0.0060 0.0105 0.2325)
+(-0.0030 0.0105 0.2325)
+(0.0000 0.0105 0.2325)
+(0.0030 0.0105 0.2325)
+(0.0060 0.0105 0.2325)
+(-0.0060 0.0135 0.2325)
+(-0.0030 0.0135 0.2325)
+(0.0000 0.0135 0.2325)
+(0.0030 0.0135 0.2325)
+(0.0060 0.0135 0.2325)
+(-0.0060 0.0165 0.2325)
+(-0.0030 0.0165 0.2325)
+(0.0000 0.0165 0.2325)
+(0.0030 0.0165 0.2325)
+(0.0060 0.0165 0.2325)
+(-0.0060 0.0195 0.2325)
+(-0.0030 0.0195 0.2325)
+(0.0000 0.0195 0.2325)
+(0.0030 0.0195 0.2325)
+(0.0060 0.0195 0.2325)
+(-0.0060 0.0225 0.2325)
+(-0.0030 0.0225 0.2325)
+(0.0000 0.0225 0.2325)
+(0.0030 0.0225 0.2325)
+(0.0060 0.0225 0.2325)
+(-0.0060 0.0255 0.2325)
+(-0.0030 0.0255 0.2325)
+(0.0000 0.0255 0.2325)
+(0.0030 0.0255 0.2325)
+(0.0060 0.0255 0.2325)
+(-0.0060 0.0285 0.2325)
+(-0.0030 0.0285 0.2325)
+(0.0000 0.0285 0.2325)
+(0.0030 0.0285 0.2325)
+(0.0060 0.0285 0.2325)
+(-0.0060 0.0315 0.2325)
+(-0.0030 0.0315 0.2325)
+(0.0000 0.0315 0.2325)
+(0.0030 0.0315 0.2325)
+(0.0060 0.0315 0.2325)
+(-0.0060 0.0345 0.2325)
+(-0.0030 0.0345 0.2325)
+(0.0000 0.0345 0.2325)
+(0.0030 0.0345 0.2325)
+(0.0060 0.0345 0.2325)
+(-0.0060 0.0375 0.2325)
+(-0.0030 0.0375 0.2325)
+(0.0000 0.0375 0.2325)
+(0.0030 0.0375 0.2325)
+(0.0060 0.0375 0.2325)
+(-0.0060 0.0405 0.2325)
+(-0.0030 0.0405 0.2325)
+(0.0000 0.0405 0.2325)
+(0.0030 0.0405 0.2325)
+(0.0060 0.0405 0.2325)
+(-0.0060 0.0435 0.2325)
+(-0.0030 0.0435 0.2325)
+(0.0000 0.0435 0.2325)
+(0.0030 0.0435 0.2325)
+(0.0060 0.0435 0.2325)
+(-0.0060 0.0465 0.2325)
+(-0.0030 0.0465 0.2325)
+(0.0000 0.0465 0.2325)
+(0.0030 0.0465 0.2325)
+(0.0060 0.0465 0.2325)
+(-0.0060 0.0495 0.2325)
+(-0.0030 0.0495 0.2325)
+(0.0000 0.0495 0.2325)
+(0.0030 0.0495 0.2325)
+(0.0060 0.0495 0.2325)
+(-0.0060 0.0525 0.2325)
+(-0.0030 0.0525 0.2325)
+(0.0000 0.0525 0.2325)
+(0.0030 0.0525 0.2325)
+(0.0060 0.0525 0.2325)
+(-0.0060 0.0555 0.2325)
+(-0.0030 0.0555 0.2325)
+(0.0000 0.0555 0.2325)
+(0.0030 0.0555 0.2325)
+(0.0060 0.0555 0.2325)
+(-0.0060 0.0585 0.2325)
+(-0.0030 0.0585 0.2325)
+(0.0000 0.0585 0.2325)
+(0.0030 0.0585 0.2325)
+(0.0060 0.0585 0.2325)
+(-0.0060 0.0615 0.2325)
+(-0.0030 0.0615 0.2325)
+(0.0000 0.0615 0.2325)
+(0.0030 0.0615 0.2325)
+(0.0060 0.0615 0.2325)
+(-0.0060 0.0645 0.2325)
+(-0.0030 0.0645 0.2325)
+(0.0000 0.0645 0.2325)
+(0.0030 0.0645 0.2325)
+(0.0060 0.0645 0.2325)
+(-0.0060 0.0675 0.2325)
+(-0.0030 0.0675 0.2325)
+(0.0000 0.0675 0.2325)
+(0.0030 0.0675 0.2325)
+(0.0060 0.0675 0.2325)
+(-0.0060 0.0705 0.2325)
+(-0.0030 0.0705 0.2325)
+(0.0000 0.0705 0.2325)
+(0.0030 0.0705 0.2325)
+(0.0060 0.0705 0.2325)
+(-0.0060 0.0735 0.2325)
+(-0.0030 0.0735 0.2325)
+(0.0000 0.0735 0.2325)
+(0.0030 0.0735 0.2325)
+(0.0060 0.0735 0.2325)
+(-0.0060 -0.0735 0.2355)
+(-0.0030 -0.0735 0.2355)
+(0.0000 -0.0735 0.2355)
+(0.0030 -0.0735 0.2355)
+(0.0060 -0.0735 0.2355)
+(-0.0060 -0.0705 0.2355)
+(-0.0030 -0.0705 0.2355)
+(0.0000 -0.0705 0.2355)
+(0.0030 -0.0705 0.2355)
+(0.0060 -0.0705 0.2355)
+(-0.0060 -0.0675 0.2355)
+(-0.0030 -0.0675 0.2355)
+(0.0000 -0.0675 0.2355)
+(0.0030 -0.0675 0.2355)
+(0.0060 -0.0675 0.2355)
+(-0.0060 -0.0645 0.2355)
+(-0.0030 -0.0645 0.2355)
+(0.0000 -0.0645 0.2355)
+(0.0030 -0.0645 0.2355)
+(0.0060 -0.0645 0.2355)
+(-0.0060 -0.0615 0.2355)
+(-0.0030 -0.0615 0.2355)
+(0.0000 -0.0615 0.2355)
+(0.0030 -0.0615 0.2355)
+(0.0060 -0.0615 0.2355)
+(-0.0060 -0.0585 0.2355)
+(-0.0030 -0.0585 0.2355)
+(0.0000 -0.0585 0.2355)
+(0.0030 -0.0585 0.2355)
+(0.0060 -0.0585 0.2355)
+(-0.0060 -0.0555 0.2355)
+(-0.0030 -0.0555 0.2355)
+(0.0000 -0.0555 0.2355)
+(0.0030 -0.0555 0.2355)
+(0.0060 -0.0555 0.2355)
+(-0.0060 -0.0525 0.2355)
+(-0.0030 -0.0525 0.2355)
+(0.0000 -0.0525 0.2355)
+(0.0030 -0.0525 0.2355)
+(0.0060 -0.0525 0.2355)
+(-0.0060 -0.0495 0.2355)
+(-0.0030 -0.0495 0.2355)
+(0.0000 -0.0495 0.2355)
+(0.0030 -0.0495 0.2355)
+(0.0060 -0.0495 0.2355)
+(-0.0060 -0.0465 0.2355)
+(-0.0030 -0.0465 0.2355)
+(0.0000 -0.0465 0.2355)
+(0.0030 -0.0465 0.2355)
+(0.0060 -0.0465 0.2355)
+(-0.0060 -0.0435 0.2355)
+(-0.0030 -0.0435 0.2355)
+(0.0000 -0.0435 0.2355)
+(0.0030 -0.0435 0.2355)
+(0.0060 -0.0435 0.2355)
+(-0.0060 -0.0405 0.2355)
+(-0.0030 -0.0405 0.2355)
+(0.0000 -0.0405 0.2355)
+(0.0030 -0.0405 0.2355)
+(0.0060 -0.0405 0.2355)
+(-0.0060 -0.0375 0.2355)
+(-0.0030 -0.0375 0.2355)
+(0.0000 -0.0375 0.2355)
+(0.0030 -0.0375 0.2355)
+(0.0060 -0.0375 0.2355)
+(-0.0060 -0.0345 0.2355)
+(-0.0030 -0.0345 0.2355)
+(0.0000 -0.0345 0.2355)
+(0.0030 -0.0345 0.2355)
+(0.0060 -0.0345 0.2355)
+(-0.0060 -0.0315 0.2355)
+(-0.0030 -0.0315 0.2355)
+(0.0000 -0.0315 0.2355)
+(0.0030 -0.0315 0.2355)
+(0.0060 -0.0315 0.2355)
+(-0.0060 -0.0285 0.2355)
+(-0.0030 -0.0285 0.2355)
+(0.0000 -0.0285 0.2355)
+(0.0030 -0.0285 0.2355)
+(0.0060 -0.0285 0.2355)
+(-0.0060 -0.0255 0.2355)
+(-0.0030 -0.0255 0.2355)
+(0.0000 -0.0255 0.2355)
+(0.0030 -0.0255 0.2355)
+(0.0060 -0.0255 0.2355)
+(-0.0060 -0.0225 0.2355)
+(-0.0030 -0.0225 0.2355)
+(0.0000 -0.0225 0.2355)
+(0.0030 -0.0225 0.2355)
+(0.0060 -0.0225 0.2355)
+(-0.0060 -0.0195 0.2355)
+(-0.0030 -0.0195 0.2355)
+(0.0000 -0.0195 0.2355)
+(0.0030 -0.0195 0.2355)
+(0.0060 -0.0195 0.2355)
+(-0.0060 -0.0165 0.2355)
+(-0.0030 -0.0165 0.2355)
+(0.0000 -0.0165 0.2355)
+(0.0030 -0.0165 0.2355)
+(0.0060 -0.0165 0.2355)
+(-0.0060 -0.0135 0.2355)
+(-0.0030 -0.0135 0.2355)
+(0.0000 -0.0135 0.2355)
+(0.0030 -0.0135 0.2355)
+(0.0060 -0.0135 0.2355)
+(-0.0060 -0.0105 0.2355)
+(-0.0030 -0.0105 0.2355)
+(0.0000 -0.0105 0.2355)
+(0.0030 -0.0105 0.2355)
+(0.0060 -0.0105 0.2355)
+(-0.0060 -0.0075 0.2355)
+(-0.0030 -0.0075 0.2355)
+(0.0000 -0.0075 0.2355)
+(0.0030 -0.0075 0.2355)
+(0.0060 -0.0075 0.2355)
+(-0.0060 -0.0045 0.2355)
+(-0.0030 -0.0045 0.2355)
+(0.0000 -0.0045 0.2355)
+(0.0030 -0.0045 0.2355)
+(0.0060 -0.0045 0.2355)
+(-0.0060 -0.0015 0.2355)
+(-0.0030 -0.0015 0.2355)
+(0.0000 -0.0015 0.2355)
+(0.0030 -0.0015 0.2355)
+(0.0060 -0.0015 0.2355)
+(-0.0060 0.0015 0.2355)
+(-0.0030 0.0015 0.2355)
+(0.0000 0.0015 0.2355)
+(0.0030 0.0015 0.2355)
+(0.0060 0.0015 0.2355)
+(-0.0060 0.0045 0.2355)
+(-0.0030 0.0045 0.2355)
+(0.0000 0.0045 0.2355)
+(0.0030 0.0045 0.2355)
+(0.0060 0.0045 0.2355)
+(-0.0060 0.0075 0.2355)
+(-0.0030 0.0075 0.2355)
+(0.0000 0.0075 0.2355)
+(0.0030 0.0075 0.2355)
+(0.0060 0.0075 0.2355)
+(-0.0060 0.0105 0.2355)
+(-0.0030 0.0105 0.2355)
+(0.0000 0.0105 0.2355)
+(0.0030 0.0105 0.2355)
+(0.0060 0.0105 0.2355)
+(-0.0060 0.0135 0.2355)
+(-0.0030 0.0135 0.2355)
+(0.0000 0.0135 0.2355)
+(0.0030 0.0135 0.2355)
+(0.0060 0.0135 0.2355)
+(-0.0060 0.0165 0.2355)
+(-0.0030 0.0165 0.2355)
+(0.0000 0.0165 0.2355)
+(0.0030 0.0165 0.2355)
+(0.0060 0.0165 0.2355)
+(-0.0060 0.0195 0.2355)
+(-0.0030 0.0195 0.2355)
+(0.0000 0.0195 0.2355)
+(0.0030 0.0195 0.2355)
+(0.0060 0.0195 0.2355)
+(-0.0060 0.0225 0.2355)
+(-0.0030 0.0225 0.2355)
+(0.0000 0.0225 0.2355)
+(0.0030 0.0225 0.2355)
+(0.0060 0.0225 0.2355)
+(-0.0060 0.0255 0.2355)
+(-0.0030 0.0255 0.2355)
+(0.0000 0.0255 0.2355)
+(0.0030 0.0255 0.2355)
+(0.0060 0.0255 0.2355)
+(-0.0060 0.0285 0.2355)
+(-0.0030 0.0285 0.2355)
+(0.0000 0.0285 0.2355)
+(0.0030 0.0285 0.2355)
+(0.0060 0.0285 0.2355)
+(-0.0060 0.0315 0.2355)
+(-0.0030 0.0315 0.2355)
+(0.0000 0.0315 0.2355)
+(0.0030 0.0315 0.2355)
+(0.0060 0.0315 0.2355)
+(-0.0060 0.0345 0.2355)
+(-0.0030 0.0345 0.2355)
+(0.0000 0.0345 0.2355)
+(0.0030 0.0345 0.2355)
+(0.0060 0.0345 0.2355)
+(-0.0060 0.0375 0.2355)
+(-0.0030 0.0375 0.2355)
+(0.0000 0.0375 0.2355)
+(0.0030 0.0375 0.2355)
+(0.0060 0.0375 0.2355)
+(-0.0060 0.0405 0.2355)
+(-0.0030 0.0405 0.2355)
+(0.0000 0.0405 0.2355)
+(0.0030 0.0405 0.2355)
+(0.0060 0.0405 0.2355)
+(-0.0060 0.0435 0.2355)
+(-0.0030 0.0435 0.2355)
+(0.0000 0.0435 0.2355)
+(0.0030 0.0435 0.2355)
+(0.0060 0.0435 0.2355)
+(-0.0060 0.0465 0.2355)
+(-0.0030 0.0465 0.2355)
+(0.0000 0.0465 0.2355)
+(0.0030 0.0465 0.2355)
+(0.0060 0.0465 0.2355)
+(-0.0060 0.0495 0.2355)
+(-0.0030 0.0495 0.2355)
+(0.0000 0.0495 0.2355)
+(0.0030 0.0495 0.2355)
+(0.0060 0.0495 0.2355)
+(-0.0060 0.0525 0.2355)
+(-0.0030 0.0525 0.2355)
+(0.0000 0.0525 0.2355)
+(0.0030 0.0525 0.2355)
+(0.0060 0.0525 0.2355)
+(-0.0060 0.0555 0.2355)
+(-0.0030 0.0555 0.2355)
+(0.0000 0.0555 0.2355)
+(0.0030 0.0555 0.2355)
+(0.0060 0.0555 0.2355)
+(-0.0060 0.0585 0.2355)
+(-0.0030 0.0585 0.2355)
+(0.0000 0.0585 0.2355)
+(0.0030 0.0585 0.2355)
+(0.0060 0.0585 0.2355)
+(-0.0060 0.0615 0.2355)
+(-0.0030 0.0615 0.2355)
+(0.0000 0.0615 0.2355)
+(0.0030 0.0615 0.2355)
+(0.0060 0.0615 0.2355)
+(-0.0060 0.0645 0.2355)
+(-0.0030 0.0645 0.2355)
+(0.0000 0.0645 0.2355)
+(0.0030 0.0645 0.2355)
+(0.0060 0.0645 0.2355)
+(-0.0060 0.0675 0.2355)
+(-0.0030 0.0675 0.2355)
+(0.0000 0.0675 0.2355)
+(0.0030 0.0675 0.2355)
+(0.0060 0.0675 0.2355)
+(-0.0060 0.0705 0.2355)
+(-0.0030 0.0705 0.2355)
+(0.0000 0.0705 0.2355)
+(0.0030 0.0705 0.2355)
+(0.0060 0.0705 0.2355)
+(-0.0060 0.0735 0.2355)
+(-0.0030 0.0735 0.2355)
+(0.0000 0.0735 0.2355)
+(0.0030 0.0735 0.2355)
+(0.0060 0.0735 0.2355)
+(-0.0060 -0.0735 0.2385)
+(-0.0030 -0.0735 0.2385)
+(0.0000 -0.0735 0.2385)
+(0.0030 -0.0735 0.2385)
+(0.0060 -0.0735 0.2385)
+(-0.0060 -0.0705 0.2385)
+(-0.0030 -0.0705 0.2385)
+(0.0000 -0.0705 0.2385)
+(0.0030 -0.0705 0.2385)
+(0.0060 -0.0705 0.2385)
+(-0.0060 -0.0675 0.2385)
+(-0.0030 -0.0675 0.2385)
+(0.0000 -0.0675 0.2385)
+(0.0030 -0.0675 0.2385)
+(0.0060 -0.0675 0.2385)
+(-0.0060 -0.0645 0.2385)
+(-0.0030 -0.0645 0.2385)
+(0.0000 -0.0645 0.2385)
+(0.0030 -0.0645 0.2385)
+(0.0060 -0.0645 0.2385)
+(-0.0060 -0.0615 0.2385)
+(-0.0030 -0.0615 0.2385)
+(0.0000 -0.0615 0.2385)
+(0.0030 -0.0615 0.2385)
+(0.0060 -0.0615 0.2385)
+(-0.0060 -0.0585 0.2385)
+(-0.0030 -0.0585 0.2385)
+(0.0000 -0.0585 0.2385)
+(0.0030 -0.0585 0.2385)
+(0.0060 -0.0585 0.2385)
+(-0.0060 -0.0555 0.2385)
+(-0.0030 -0.0555 0.2385)
+(0.0000 -0.0555 0.2385)
+(0.0030 -0.0555 0.2385)
+(0.0060 -0.0555 0.2385)
+(-0.0060 -0.0525 0.2385)
+(-0.0030 -0.0525 0.2385)
+(0.0000 -0.0525 0.2385)
+(0.0030 -0.0525 0.2385)
+(0.0060 -0.0525 0.2385)
+(-0.0060 -0.0495 0.2385)
+(-0.0030 -0.0495 0.2385)
+(0.0000 -0.0495 0.2385)
+(0.0030 -0.0495 0.2385)
+(0.0060 -0.0495 0.2385)
+(-0.0060 -0.0465 0.2385)
+(-0.0030 -0.0465 0.2385)
+(0.0000 -0.0465 0.2385)
+(0.0030 -0.0465 0.2385)
+(0.0060 -0.0465 0.2385)
+(-0.0060 -0.0435 0.2385)
+(-0.0030 -0.0435 0.2385)
+(0.0000 -0.0435 0.2385)
+(0.0030 -0.0435 0.2385)
+(0.0060 -0.0435 0.2385)
+(-0.0060 -0.0405 0.2385)
+(-0.0030 -0.0405 0.2385)
+(0.0000 -0.0405 0.2385)
+(0.0030 -0.0405 0.2385)
+(0.0060 -0.0405 0.2385)
+(-0.0060 -0.0375 0.2385)
+(-0.0030 -0.0375 0.2385)
+(0.0000 -0.0375 0.2385)
+(0.0030 -0.0375 0.2385)
+(0.0060 -0.0375 0.2385)
+(-0.0060 -0.0345 0.2385)
+(-0.0030 -0.0345 0.2385)
+(0.0000 -0.0345 0.2385)
+(0.0030 -0.0345 0.2385)
+(0.0060 -0.0345 0.2385)
+(-0.0060 -0.0315 0.2385)
+(-0.0030 -0.0315 0.2385)
+(0.0000 -0.0315 0.2385)
+(0.0030 -0.0315 0.2385)
+(0.0060 -0.0315 0.2385)
+(-0.0060 -0.0285 0.2385)
+(-0.0030 -0.0285 0.2385)
+(0.0000 -0.0285 0.2385)
+(0.0030 -0.0285 0.2385)
+(0.0060 -0.0285 0.2385)
+(-0.0060 -0.0255 0.2385)
+(-0.0030 -0.0255 0.2385)
+(0.0000 -0.0255 0.2385)
+(0.0030 -0.0255 0.2385)
+(0.0060 -0.0255 0.2385)
+(-0.0060 -0.0225 0.2385)
+(-0.0030 -0.0225 0.2385)
+(0.0000 -0.0225 0.2385)
+(0.0030 -0.0225 0.2385)
+(0.0060 -0.0225 0.2385)
+(-0.0060 -0.0195 0.2385)
+(-0.0030 -0.0195 0.2385)
+(0.0000 -0.0195 0.2385)
+(0.0030 -0.0195 0.2385)
+(0.0060 -0.0195 0.2385)
+(-0.0060 -0.0165 0.2385)
+(-0.0030 -0.0165 0.2385)
+(0.0000 -0.0165 0.2385)
+(0.0030 -0.0165 0.2385)
+(0.0060 -0.0165 0.2385)
+(-0.0060 -0.0135 0.2385)
+(-0.0030 -0.0135 0.2385)
+(0.0000 -0.0135 0.2385)
+(0.0030 -0.0135 0.2385)
+(0.0060 -0.0135 0.2385)
+(-0.0060 -0.0105 0.2385)
+(-0.0030 -0.0105 0.2385)
+(0.0000 -0.0105 0.2385)
+(0.0030 -0.0105 0.2385)
+(0.0060 -0.0105 0.2385)
+(-0.0060 -0.0075 0.2385)
+(-0.0030 -0.0075 0.2385)
+(0.0000 -0.0075 0.2385)
+(0.0030 -0.0075 0.2385)
+(0.0060 -0.0075 0.2385)
+(-0.0060 -0.0045 0.2385)
+(-0.0030 -0.0045 0.2385)
+(0.0000 -0.0045 0.2385)
+(0.0030 -0.0045 0.2385)
+(0.0060 -0.0045 0.2385)
+(-0.0060 -0.0015 0.2385)
+(-0.0030 -0.0015 0.2385)
+(0.0000 -0.0015 0.2385)
+(0.0030 -0.0015 0.2385)
+(0.0060 -0.0015 0.2385)
+(-0.0060 0.0015 0.2385)
+(-0.0030 0.0015 0.2385)
+(0.0000 0.0015 0.2385)
+(0.0030 0.0015 0.2385)
+(0.0060 0.0015 0.2385)
+(-0.0060 0.0045 0.2385)
+(-0.0030 0.0045 0.2385)
+(0.0000 0.0045 0.2385)
+(0.0030 0.0045 0.2385)
+(0.0060 0.0045 0.2385)
+(-0.0060 0.0075 0.2385)
+(-0.0030 0.0075 0.2385)
+(0.0000 0.0075 0.2385)
+(0.0030 0.0075 0.2385)
+(0.0060 0.0075 0.2385)
+(-0.0060 0.0105 0.2385)
+(-0.0030 0.0105 0.2385)
+(0.0000 0.0105 0.2385)
+(0.0030 0.0105 0.2385)
+(0.0060 0.0105 0.2385)
+(-0.0060 0.0135 0.2385)
+(-0.0030 0.0135 0.2385)
+(0.0000 0.0135 0.2385)
+(0.0030 0.0135 0.2385)
+(0.0060 0.0135 0.2385)
+(-0.0060 0.0165 0.2385)
+(-0.0030 0.0165 0.2385)
+(0.0000 0.0165 0.2385)
+(0.0030 0.0165 0.2385)
+(0.0060 0.0165 0.2385)
+(-0.0060 0.0195 0.2385)
+(-0.0030 0.0195 0.2385)
+(0.0000 0.0195 0.2385)
+(0.0030 0.0195 0.2385)
+(0.0060 0.0195 0.2385)
+(-0.0060 0.0225 0.2385)
+(-0.0030 0.0225 0.2385)
+(0.0000 0.0225 0.2385)
+(0.0030 0.0225 0.2385)
+(0.0060 0.0225 0.2385)
+(-0.0060 0.0255 0.2385)
+(-0.0030 0.0255 0.2385)
+(0.0000 0.0255 0.2385)
+(0.0030 0.0255 0.2385)
+(0.0060 0.0255 0.2385)
+(-0.0060 0.0285 0.2385)
+(-0.0030 0.0285 0.2385)
+(0.0000 0.0285 0.2385)
+(0.0030 0.0285 0.2385)
+(0.0060 0.0285 0.2385)
+(-0.0060 0.0315 0.2385)
+(-0.0030 0.0315 0.2385)
+(0.0000 0.0315 0.2385)
+(0.0030 0.0315 0.2385)
+(0.0060 0.0315 0.2385)
+(-0.0060 0.0345 0.2385)
+(-0.0030 0.0345 0.2385)
+(0.0000 0.0345 0.2385)
+(0.0030 0.0345 0.2385)
+(0.0060 0.0345 0.2385)
+(-0.0060 0.0375 0.2385)
+(-0.0030 0.0375 0.2385)
+(0.0000 0.0375 0.2385)
+(0.0030 0.0375 0.2385)
+(0.0060 0.0375 0.2385)
+(-0.0060 0.0405 0.2385)
+(-0.0030 0.0405 0.2385)
+(0.0000 0.0405 0.2385)
+(0.0030 0.0405 0.2385)
+(0.0060 0.0405 0.2385)
+(-0.0060 0.0435 0.2385)
+(-0.0030 0.0435 0.2385)
+(0.0000 0.0435 0.2385)
+(0.0030 0.0435 0.2385)
+(0.0060 0.0435 0.2385)
+(-0.0060 0.0465 0.2385)
+(-0.0030 0.0465 0.2385)
+(0.0000 0.0465 0.2385)
+(0.0030 0.0465 0.2385)
+(0.0060 0.0465 0.2385)
+(-0.0060 0.0495 0.2385)
+(-0.0030 0.0495 0.2385)
+(0.0000 0.0495 0.2385)
+(0.0030 0.0495 0.2385)
+(0.0060 0.0495 0.2385)
+(-0.0060 0.0525 0.2385)
+(-0.0030 0.0525 0.2385)
+(0.0000 0.0525 0.2385)
+(0.0030 0.0525 0.2385)
+(0.0060 0.0525 0.2385)
+(-0.0060 0.0555 0.2385)
+(-0.0030 0.0555 0.2385)
+(0.0000 0.0555 0.2385)
+(0.0030 0.0555 0.2385)
+(0.0060 0.0555 0.2385)
+(-0.0060 0.0585 0.2385)
+(-0.0030 0.0585 0.2385)
+(0.0000 0.0585 0.2385)
+(0.0030 0.0585 0.2385)
+(0.0060 0.0585 0.2385)
+(-0.0060 0.0615 0.2385)
+(-0.0030 0.0615 0.2385)
+(0.0000 0.0615 0.2385)
+(0.0030 0.0615 0.2385)
+(0.0060 0.0615 0.2385)
+(-0.0060 0.0645 0.2385)
+(-0.0030 0.0645 0.2385)
+(0.0000 0.0645 0.2385)
+(0.0030 0.0645 0.2385)
+(0.0060 0.0645 0.2385)
+(-0.0060 0.0675 0.2385)
+(-0.0030 0.0675 0.2385)
+(0.0000 0.0675 0.2385)
+(0.0030 0.0675 0.2385)
+(0.0060 0.0675 0.2385)
+(-0.0060 0.0705 0.2385)
+(-0.0030 0.0705 0.2385)
+(0.0000 0.0705 0.2385)
+(0.0030 0.0705 0.2385)
+(0.0060 0.0705 0.2385)
+(-0.0060 0.0735 0.2385)
+(-0.0030 0.0735 0.2385)
+(0.0000 0.0735 0.2385)
+(0.0030 0.0735 0.2385)
+(0.0060 0.0735 0.2385)
+(-0.0060 -0.0735 0.2415)
+(-0.0030 -0.0735 0.2415)
+(0.0000 -0.0735 0.2415)
+(0.0030 -0.0735 0.2415)
+(0.0060 -0.0735 0.2415)
+(-0.0060 -0.0705 0.2415)
+(-0.0030 -0.0705 0.2415)
+(0.0000 -0.0705 0.2415)
+(0.0030 -0.0705 0.2415)
+(0.0060 -0.0705 0.2415)
+(-0.0060 -0.0675 0.2415)
+(-0.0030 -0.0675 0.2415)
+(0.0000 -0.0675 0.2415)
+(0.0030 -0.0675 0.2415)
+(0.0060 -0.0675 0.2415)
+(-0.0060 -0.0645 0.2415)
+(-0.0030 -0.0645 0.2415)
+(0.0000 -0.0645 0.2415)
+(0.0030 -0.0645 0.2415)
+(0.0060 -0.0645 0.2415)
+(-0.0060 -0.0615 0.2415)
+(-0.0030 -0.0615 0.2415)
+(0.0000 -0.0615 0.2415)
+(0.0030 -0.0615 0.2415)
+(0.0060 -0.0615 0.2415)
+(-0.0060 -0.0585 0.2415)
+(-0.0030 -0.0585 0.2415)
+(0.0000 -0.0585 0.2415)
+(0.0030 -0.0585 0.2415)
+(0.0060 -0.0585 0.2415)
+(-0.0060 -0.0555 0.2415)
+(-0.0030 -0.0555 0.2415)
+(0.0000 -0.0555 0.2415)
+(0.0030 -0.0555 0.2415)
+(0.0060 -0.0555 0.2415)
+(-0.0060 -0.0525 0.2415)
+(-0.0030 -0.0525 0.2415)
+(0.0000 -0.0525 0.2415)
+(0.0030 -0.0525 0.2415)
+(0.0060 -0.0525 0.2415)
+(-0.0060 -0.0495 0.2415)
+(-0.0030 -0.0495 0.2415)
+(0.0000 -0.0495 0.2415)
+(0.0030 -0.0495 0.2415)
+(0.0060 -0.0495 0.2415)
+(-0.0060 -0.0465 0.2415)
+(-0.0030 -0.0465 0.2415)
+(0.0000 -0.0465 0.2415)
+(0.0030 -0.0465 0.2415)
+(0.0060 -0.0465 0.2415)
+(-0.0060 -0.0435 0.2415)
+(-0.0030 -0.0435 0.2415)
+(0.0000 -0.0435 0.2415)
+(0.0030 -0.0435 0.2415)
+(0.0060 -0.0435 0.2415)
+(-0.0060 -0.0405 0.2415)
+(-0.0030 -0.0405 0.2415)
+(0.0000 -0.0405 0.2415)
+(0.0030 -0.0405 0.2415)
+(0.0060 -0.0405 0.2415)
+(-0.0060 -0.0375 0.2415)
+(-0.0030 -0.0375 0.2415)
+(0.0000 -0.0375 0.2415)
+(0.0030 -0.0375 0.2415)
+(0.0060 -0.0375 0.2415)
+(-0.0060 -0.0345 0.2415)
+(-0.0030 -0.0345 0.2415)
+(0.0000 -0.0345 0.2415)
+(0.0030 -0.0345 0.2415)
+(0.0060 -0.0345 0.2415)
+(-0.0060 -0.0315 0.2415)
+(-0.0030 -0.0315 0.2415)
+(0.0000 -0.0315 0.2415)
+(0.0030 -0.0315 0.2415)
+(0.0060 -0.0315 0.2415)
+(-0.0060 -0.0285 0.2415)
+(-0.0030 -0.0285 0.2415)
+(0.0000 -0.0285 0.2415)
+(0.0030 -0.0285 0.2415)
+(0.0060 -0.0285 0.2415)
+(-0.0060 -0.0255 0.2415)
+(-0.0030 -0.0255 0.2415)
+(0.0000 -0.0255 0.2415)
+(0.0030 -0.0255 0.2415)
+(0.0060 -0.0255 0.2415)
+(-0.0060 -0.0225 0.2415)
+(-0.0030 -0.0225 0.2415)
+(0.0000 -0.0225 0.2415)
+(0.0030 -0.0225 0.2415)
+(0.0060 -0.0225 0.2415)
+(-0.0060 -0.0195 0.2415)
+(-0.0030 -0.0195 0.2415)
+(0.0000 -0.0195 0.2415)
+(0.0030 -0.0195 0.2415)
+(0.0060 -0.0195 0.2415)
+(-0.0060 -0.0165 0.2415)
+(-0.0030 -0.0165 0.2415)
+(0.0000 -0.0165 0.2415)
+(0.0030 -0.0165 0.2415)
+(0.0060 -0.0165 0.2415)
+(-0.0060 -0.0135 0.2415)
+(-0.0030 -0.0135 0.2415)
+(0.0000 -0.0135 0.2415)
+(0.0030 -0.0135 0.2415)
+(0.0060 -0.0135 0.2415)
+(-0.0060 -0.0105 0.2415)
+(-0.0030 -0.0105 0.2415)
+(0.0000 -0.0105 0.2415)
+(0.0030 -0.0105 0.2415)
+(0.0060 -0.0105 0.2415)
+(-0.0060 -0.0075 0.2415)
+(-0.0030 -0.0075 0.2415)
+(0.0000 -0.0075 0.2415)
+(0.0030 -0.0075 0.2415)
+(0.0060 -0.0075 0.2415)
+(-0.0060 -0.0045 0.2415)
+(-0.0030 -0.0045 0.2415)
+(0.0000 -0.0045 0.2415)
+(0.0030 -0.0045 0.2415)
+(0.0060 -0.0045 0.2415)
+(-0.0060 -0.0015 0.2415)
+(-0.0030 -0.0015 0.2415)
+(0.0000 -0.0015 0.2415)
+(0.0030 -0.0015 0.2415)
+(0.0060 -0.0015 0.2415)
+(-0.0060 0.0015 0.2415)
+(-0.0030 0.0015 0.2415)
+(0.0000 0.0015 0.2415)
+(0.0030 0.0015 0.2415)
+(0.0060 0.0015 0.2415)
+(-0.0060 0.0045 0.2415)
+(-0.0030 0.0045 0.2415)
+(0.0000 0.0045 0.2415)
+(0.0030 0.0045 0.2415)
+(0.0060 0.0045 0.2415)
+(-0.0060 0.0075 0.2415)
+(-0.0030 0.0075 0.2415)
+(0.0000 0.0075 0.2415)
+(0.0030 0.0075 0.2415)
+(0.0060 0.0075 0.2415)
+(-0.0060 0.0105 0.2415)
+(-0.0030 0.0105 0.2415)
+(0.0000 0.0105 0.2415)
+(0.0030 0.0105 0.2415)
+(0.0060 0.0105 0.2415)
+(-0.0060 0.0135 0.2415)
+(-0.0030 0.0135 0.2415)
+(0.0000 0.0135 0.2415)
+(0.0030 0.0135 0.2415)
+(0.0060 0.0135 0.2415)
+(-0.0060 0.0165 0.2415)
+(-0.0030 0.0165 0.2415)
+(0.0000 0.0165 0.2415)
+(0.0030 0.0165 0.2415)
+(0.0060 0.0165 0.2415)
+(-0.0060 0.0195 0.2415)
+(-0.0030 0.0195 0.2415)
+(0.0000 0.0195 0.2415)
+(0.0030 0.0195 0.2415)
+(0.0060 0.0195 0.2415)
+(-0.0060 0.0225 0.2415)
+(-0.0030 0.0225 0.2415)
+(0.0000 0.0225 0.2415)
+(0.0030 0.0225 0.2415)
+(0.0060 0.0225 0.2415)
+(-0.0060 0.0255 0.2415)
+(-0.0030 0.0255 0.2415)
+(0.0000 0.0255 0.2415)
+(0.0030 0.0255 0.2415)
+(0.0060 0.0255 0.2415)
+(-0.0060 0.0285 0.2415)
+(-0.0030 0.0285 0.2415)
+(0.0000 0.0285 0.2415)
+(0.0030 0.0285 0.2415)
+(0.0060 0.0285 0.2415)
+(-0.0060 0.0315 0.2415)
+(-0.0030 0.0315 0.2415)
+(0.0000 0.0315 0.2415)
+(0.0030 0.0315 0.2415)
+(0.0060 0.0315 0.2415)
+(-0.0060 0.0345 0.2415)
+(-0.0030 0.0345 0.2415)
+(0.0000 0.0345 0.2415)
+(0.0030 0.0345 0.2415)
+(0.0060 0.0345 0.2415)
+(-0.0060 0.0375 0.2415)
+(-0.0030 0.0375 0.2415)
+(0.0000 0.0375 0.2415)
+(0.0030 0.0375 0.2415)
+(0.0060 0.0375 0.2415)
+(-0.0060 0.0405 0.2415)
+(-0.0030 0.0405 0.2415)
+(0.0000 0.0405 0.2415)
+(0.0030 0.0405 0.2415)
+(0.0060 0.0405 0.2415)
+(-0.0060 0.0435 0.2415)
+(-0.0030 0.0435 0.2415)
+(0.0000 0.0435 0.2415)
+(0.0030 0.0435 0.2415)
+(0.0060 0.0435 0.2415)
+(-0.0060 0.0465 0.2415)
+(-0.0030 0.0465 0.2415)
+(0.0000 0.0465 0.2415)
+(0.0030 0.0465 0.2415)
+(0.0060 0.0465 0.2415)
+(-0.0060 0.0495 0.2415)
+(-0.0030 0.0495 0.2415)
+(0.0000 0.0495 0.2415)
+(0.0030 0.0495 0.2415)
+(0.0060 0.0495 0.2415)
+(-0.0060 0.0525 0.2415)
+(-0.0030 0.0525 0.2415)
+(0.0000 0.0525 0.2415)
+(0.0030 0.0525 0.2415)
+(0.0060 0.0525 0.2415)
+(-0.0060 0.0555 0.2415)
+(-0.0030 0.0555 0.2415)
+(0.0000 0.0555 0.2415)
+(0.0030 0.0555 0.2415)
+(0.0060 0.0555 0.2415)
+(-0.0060 0.0585 0.2415)
+(-0.0030 0.0585 0.2415)
+(0.0000 0.0585 0.2415)
+(0.0030 0.0585 0.2415)
+(0.0060 0.0585 0.2415)
+(-0.0060 0.0615 0.2415)
+(-0.0030 0.0615 0.2415)
+(0.0000 0.0615 0.2415)
+(0.0030 0.0615 0.2415)
+(0.0060 0.0615 0.2415)
+(-0.0060 0.0645 0.2415)
+(-0.0030 0.0645 0.2415)
+(0.0000 0.0645 0.2415)
+(0.0030 0.0645 0.2415)
+(0.0060 0.0645 0.2415)
+(-0.0060 0.0675 0.2415)
+(-0.0030 0.0675 0.2415)
+(0.0000 0.0675 0.2415)
+(0.0030 0.0675 0.2415)
+(0.0060 0.0675 0.2415)
+(-0.0060 0.0705 0.2415)
+(-0.0030 0.0705 0.2415)
+(0.0000 0.0705 0.2415)
+(0.0030 0.0705 0.2415)
+(0.0060 0.0705 0.2415)
+(-0.0060 0.0735 0.2415)
+(-0.0030 0.0735 0.2415)
+(0.0000 0.0735 0.2415)
+(0.0030 0.0735 0.2415)
+(0.0060 0.0735 0.2415)
+(-0.0060 -0.0735 0.2445)
+(-0.0030 -0.0735 0.2445)
+(0.0000 -0.0735 0.2445)
+(0.0030 -0.0735 0.2445)
+(0.0060 -0.0735 0.2445)
+(-0.0060 -0.0705 0.2445)
+(-0.0030 -0.0705 0.2445)
+(0.0000 -0.0705 0.2445)
+(0.0030 -0.0705 0.2445)
+(0.0060 -0.0705 0.2445)
+(-0.0060 -0.0675 0.2445)
+(-0.0030 -0.0675 0.2445)
+(0.0000 -0.0675 0.2445)
+(0.0030 -0.0675 0.2445)
+(0.0060 -0.0675 0.2445)
+(-0.0060 -0.0645 0.2445)
+(-0.0030 -0.0645 0.2445)
+(0.0000 -0.0645 0.2445)
+(0.0030 -0.0645 0.2445)
+(0.0060 -0.0645 0.2445)
+(-0.0060 -0.0615 0.2445)
+(-0.0030 -0.0615 0.2445)
+(0.0000 -0.0615 0.2445)
+(0.0030 -0.0615 0.2445)
+(0.0060 -0.0615 0.2445)
+(-0.0060 -0.0585 0.2445)
+(-0.0030 -0.0585 0.2445)
+(0.0000 -0.0585 0.2445)
+(0.0030 -0.0585 0.2445)
+(0.0060 -0.0585 0.2445)
+(-0.0060 -0.0555 0.2445)
+(-0.0030 -0.0555 0.2445)
+(0.0000 -0.0555 0.2445)
+(0.0030 -0.0555 0.2445)
+(0.0060 -0.0555 0.2445)
+(-0.0060 -0.0525 0.2445)
+(-0.0030 -0.0525 0.2445)
+(0.0000 -0.0525 0.2445)
+(0.0030 -0.0525 0.2445)
+(0.0060 -0.0525 0.2445)
+(-0.0060 -0.0495 0.2445)
+(-0.0030 -0.0495 0.2445)
+(0.0000 -0.0495 0.2445)
+(0.0030 -0.0495 0.2445)
+(0.0060 -0.0495 0.2445)
+(-0.0060 -0.0465 0.2445)
+(-0.0030 -0.0465 0.2445)
+(0.0000 -0.0465 0.2445)
+(0.0030 -0.0465 0.2445)
+(0.0060 -0.0465 0.2445)
+(-0.0060 -0.0435 0.2445)
+(-0.0030 -0.0435 0.2445)
+(0.0000 -0.0435 0.2445)
+(0.0030 -0.0435 0.2445)
+(0.0060 -0.0435 0.2445)
+(-0.0060 -0.0405 0.2445)
+(-0.0030 -0.0405 0.2445)
+(0.0000 -0.0405 0.2445)
+(0.0030 -0.0405 0.2445)
+(0.0060 -0.0405 0.2445)
+(-0.0060 -0.0375 0.2445)
+(-0.0030 -0.0375 0.2445)
+(0.0000 -0.0375 0.2445)
+(0.0030 -0.0375 0.2445)
+(0.0060 -0.0375 0.2445)
+(-0.0060 -0.0345 0.2445)
+(-0.0030 -0.0345 0.2445)
+(0.0000 -0.0345 0.2445)
+(0.0030 -0.0345 0.2445)
+(0.0060 -0.0345 0.2445)
+(-0.0060 -0.0315 0.2445)
+(-0.0030 -0.0315 0.2445)
+(0.0000 -0.0315 0.2445)
+(0.0030 -0.0315 0.2445)
+(0.0060 -0.0315 0.2445)
+(-0.0060 -0.0285 0.2445)
+(-0.0030 -0.0285 0.2445)
+(0.0000 -0.0285 0.2445)
+(0.0030 -0.0285 0.2445)
+(0.0060 -0.0285 0.2445)
+(-0.0060 -0.0255 0.2445)
+(-0.0030 -0.0255 0.2445)
+(0.0000 -0.0255 0.2445)
+(0.0030 -0.0255 0.2445)
+(0.0060 -0.0255 0.2445)
+(-0.0060 -0.0225 0.2445)
+(-0.0030 -0.0225 0.2445)
+(0.0000 -0.0225 0.2445)
+(0.0030 -0.0225 0.2445)
+(0.0060 -0.0225 0.2445)
+(-0.0060 -0.0195 0.2445)
+(-0.0030 -0.0195 0.2445)
+(0.0000 -0.0195 0.2445)
+(0.0030 -0.0195 0.2445)
+(0.0060 -0.0195 0.2445)
+(-0.0060 -0.0165 0.2445)
+(-0.0030 -0.0165 0.2445)
+(0.0000 -0.0165 0.2445)
+(0.0030 -0.0165 0.2445)
+(0.0060 -0.0165 0.2445)
+(-0.0060 -0.0135 0.2445)
+(-0.0030 -0.0135 0.2445)
+(0.0000 -0.0135 0.2445)
+(0.0030 -0.0135 0.2445)
+(0.0060 -0.0135 0.2445)
+(-0.0060 -0.0105 0.2445)
+(-0.0030 -0.0105 0.2445)
+(0.0000 -0.0105 0.2445)
+(0.0030 -0.0105 0.2445)
+(0.0060 -0.0105 0.2445)
+(-0.0060 -0.0075 0.2445)
+(-0.0030 -0.0075 0.2445)
+(0.0000 -0.0075 0.2445)
+(0.0030 -0.0075 0.2445)
+(0.0060 -0.0075 0.2445)
+(-0.0060 -0.0045 0.2445)
+(-0.0030 -0.0045 0.2445)
+(0.0000 -0.0045 0.2445)
+(0.0030 -0.0045 0.2445)
+(0.0060 -0.0045 0.2445)
+(-0.0060 -0.0015 0.2445)
+(-0.0030 -0.0015 0.2445)
+(0.0000 -0.0015 0.2445)
+(0.0030 -0.0015 0.2445)
+(0.0060 -0.0015 0.2445)
+(-0.0060 0.0015 0.2445)
+(-0.0030 0.0015 0.2445)
+(0.0000 0.0015 0.2445)
+(0.0030 0.0015 0.2445)
+(0.0060 0.0015 0.2445)
+(-0.0060 0.0045 0.2445)
+(-0.0030 0.0045 0.2445)
+(0.0000 0.0045 0.2445)
+(0.0030 0.0045 0.2445)
+(0.0060 0.0045 0.2445)
+(-0.0060 0.0075 0.2445)
+(-0.0030 0.0075 0.2445)
+(0.0000 0.0075 0.2445)
+(0.0030 0.0075 0.2445)
+(0.0060 0.0075 0.2445)
+(-0.0060 0.0105 0.2445)
+(-0.0030 0.0105 0.2445)
+(0.0000 0.0105 0.2445)
+(0.0030 0.0105 0.2445)
+(0.0060 0.0105 0.2445)
+(-0.0060 0.0135 0.2445)
+(-0.0030 0.0135 0.2445)
+(0.0000 0.0135 0.2445)
+(0.0030 0.0135 0.2445)
+(0.0060 0.0135 0.2445)
+(-0.0060 0.0165 0.2445)
+(-0.0030 0.0165 0.2445)
+(0.0000 0.0165 0.2445)
+(0.0030 0.0165 0.2445)
+(0.0060 0.0165 0.2445)
+(-0.0060 0.0195 0.2445)
+(-0.0030 0.0195 0.2445)
+(0.0000 0.0195 0.2445)
+(0.0030 0.0195 0.2445)
+(0.0060 0.0195 0.2445)
+(-0.0060 0.0225 0.2445)
+(-0.0030 0.0225 0.2445)
+(0.0000 0.0225 0.2445)
+(0.0030 0.0225 0.2445)
+(0.0060 0.0225 0.2445)
+(-0.0060 0.0255 0.2445)
+(-0.0030 0.0255 0.2445)
+(0.0000 0.0255 0.2445)
+(0.0030 0.0255 0.2445)
+(0.0060 0.0255 0.2445)
+(-0.0060 0.0285 0.2445)
+(-0.0030 0.0285 0.2445)
+(0.0000 0.0285 0.2445)
+(0.0030 0.0285 0.2445)
+(0.0060 0.0285 0.2445)
+(-0.0060 0.0315 0.2445)
+(-0.0030 0.0315 0.2445)
+(0.0000 0.0315 0.2445)
+(0.0030 0.0315 0.2445)
+(0.0060 0.0315 0.2445)
+(-0.0060 0.0345 0.2445)
+(-0.0030 0.0345 0.2445)
+(0.0000 0.0345 0.2445)
+(0.0030 0.0345 0.2445)
+(0.0060 0.0345 0.2445)
+(-0.0060 0.0375 0.2445)
+(-0.0030 0.0375 0.2445)
+(0.0000 0.0375 0.2445)
+(0.0030 0.0375 0.2445)
+(0.0060 0.0375 0.2445)
+(-0.0060 0.0405 0.2445)
+(-0.0030 0.0405 0.2445)
+(0.0000 0.0405 0.2445)
+(0.0030 0.0405 0.2445)
+(0.0060 0.0405 0.2445)
+(-0.0060 0.0435 0.2445)
+(-0.0030 0.0435 0.2445)
+(0.0000 0.0435 0.2445)
+(0.0030 0.0435 0.2445)
+(0.0060 0.0435 0.2445)
+(-0.0060 0.0465 0.2445)
+(-0.0030 0.0465 0.2445)
+(0.0000 0.0465 0.2445)
+(0.0030 0.0465 0.2445)
+(0.0060 0.0465 0.2445)
+(-0.0060 0.0495 0.2445)
+(-0.0030 0.0495 0.2445)
+(0.0000 0.0495 0.2445)
+(0.0030 0.0495 0.2445)
+(0.0060 0.0495 0.2445)
+(-0.0060 0.0525 0.2445)
+(-0.0030 0.0525 0.2445)
+(0.0000 0.0525 0.2445)
+(0.0030 0.0525 0.2445)
+(0.0060 0.0525 0.2445)
+(-0.0060 0.0555 0.2445)
+(-0.0030 0.0555 0.2445)
+(0.0000 0.0555 0.2445)
+(0.0030 0.0555 0.2445)
+(0.0060 0.0555 0.2445)
+(-0.0060 0.0585 0.2445)
+(-0.0030 0.0585 0.2445)
+(0.0000 0.0585 0.2445)
+(0.0030 0.0585 0.2445)
+(0.0060 0.0585 0.2445)
+(-0.0060 0.0615 0.2445)
+(-0.0030 0.0615 0.2445)
+(0.0000 0.0615 0.2445)
+(0.0030 0.0615 0.2445)
+(0.0060 0.0615 0.2445)
+(-0.0060 0.0645 0.2445)
+(-0.0030 0.0645 0.2445)
+(0.0000 0.0645 0.2445)
+(0.0030 0.0645 0.2445)
+(0.0060 0.0645 0.2445)
+(-0.0060 0.0675 0.2445)
+(-0.0030 0.0675 0.2445)
+(0.0000 0.0675 0.2445)
+(0.0030 0.0675 0.2445)
+(0.0060 0.0675 0.2445)
+(-0.0060 0.0705 0.2445)
+(-0.0030 0.0705 0.2445)
+(0.0000 0.0705 0.2445)
+(0.0030 0.0705 0.2445)
+(0.0060 0.0705 0.2445)
+(-0.0060 0.0735 0.2445)
+(-0.0030 0.0735 0.2445)
+(0.0000 0.0735 0.2445)
+(0.0030 0.0735 0.2445)
+(0.0060 0.0735 0.2445)
+(-0.0060 -0.0735 0.2475)
+(-0.0030 -0.0735 0.2475)
+(0.0000 -0.0735 0.2475)
+(0.0030 -0.0735 0.2475)
+(0.0060 -0.0735 0.2475)
+(-0.0060 -0.0705 0.2475)
+(-0.0030 -0.0705 0.2475)
+(0.0000 -0.0705 0.2475)
+(0.0030 -0.0705 0.2475)
+(0.0060 -0.0705 0.2475)
+(-0.0060 -0.0675 0.2475)
+(-0.0030 -0.0675 0.2475)
+(0.0000 -0.0675 0.2475)
+(0.0030 -0.0675 0.2475)
+(0.0060 -0.0675 0.2475)
+(-0.0060 -0.0645 0.2475)
+(-0.0030 -0.0645 0.2475)
+(0.0000 -0.0645 0.2475)
+(0.0030 -0.0645 0.2475)
+(0.0060 -0.0645 0.2475)
+(-0.0060 -0.0615 0.2475)
+(-0.0030 -0.0615 0.2475)
+(0.0000 -0.0615 0.2475)
+(0.0030 -0.0615 0.2475)
+(0.0060 -0.0615 0.2475)
+(-0.0060 -0.0585 0.2475)
+(-0.0030 -0.0585 0.2475)
+(0.0000 -0.0585 0.2475)
+(0.0030 -0.0585 0.2475)
+(0.0060 -0.0585 0.2475)
+(-0.0060 -0.0555 0.2475)
+(-0.0030 -0.0555 0.2475)
+(0.0000 -0.0555 0.2475)
+(0.0030 -0.0555 0.2475)
+(0.0060 -0.0555 0.2475)
+(-0.0060 -0.0525 0.2475)
+(-0.0030 -0.0525 0.2475)
+(0.0000 -0.0525 0.2475)
+(0.0030 -0.0525 0.2475)
+(0.0060 -0.0525 0.2475)
+(-0.0060 -0.0495 0.2475)
+(-0.0030 -0.0495 0.2475)
+(0.0000 -0.0495 0.2475)
+(0.0030 -0.0495 0.2475)
+(0.0060 -0.0495 0.2475)
+(-0.0060 -0.0465 0.2475)
+(-0.0030 -0.0465 0.2475)
+(0.0000 -0.0465 0.2475)
+(0.0030 -0.0465 0.2475)
+(0.0060 -0.0465 0.2475)
+(-0.0060 -0.0435 0.2475)
+(-0.0030 -0.0435 0.2475)
+(0.0000 -0.0435 0.2475)
+(0.0030 -0.0435 0.2475)
+(0.0060 -0.0435 0.2475)
+(-0.0060 -0.0405 0.2475)
+(-0.0030 -0.0405 0.2475)
+(0.0000 -0.0405 0.2475)
+(0.0030 -0.0405 0.2475)
+(0.0060 -0.0405 0.2475)
+(-0.0060 -0.0375 0.2475)
+(-0.0030 -0.0375 0.2475)
+(0.0000 -0.0375 0.2475)
+(0.0030 -0.0375 0.2475)
+(0.0060 -0.0375 0.2475)
+(-0.0060 -0.0345 0.2475)
+(-0.0030 -0.0345 0.2475)
+(0.0000 -0.0345 0.2475)
+(0.0030 -0.0345 0.2475)
+(0.0060 -0.0345 0.2475)
+(-0.0060 -0.0315 0.2475)
+(-0.0030 -0.0315 0.2475)
+(0.0000 -0.0315 0.2475)
+(0.0030 -0.0315 0.2475)
+(0.0060 -0.0315 0.2475)
+(-0.0060 -0.0285 0.2475)
+(-0.0030 -0.0285 0.2475)
+(0.0000 -0.0285 0.2475)
+(0.0030 -0.0285 0.2475)
+(0.0060 -0.0285 0.2475)
+(-0.0060 -0.0255 0.2475)
+(-0.0030 -0.0255 0.2475)
+(0.0000 -0.0255 0.2475)
+(0.0030 -0.0255 0.2475)
+(0.0060 -0.0255 0.2475)
+(-0.0060 -0.0225 0.2475)
+(-0.0030 -0.0225 0.2475)
+(0.0000 -0.0225 0.2475)
+(0.0030 -0.0225 0.2475)
+(0.0060 -0.0225 0.2475)
+(-0.0060 -0.0195 0.2475)
+(-0.0030 -0.0195 0.2475)
+(0.0000 -0.0195 0.2475)
+(0.0030 -0.0195 0.2475)
+(0.0060 -0.0195 0.2475)
+(-0.0060 -0.0165 0.2475)
+(-0.0030 -0.0165 0.2475)
+(0.0000 -0.0165 0.2475)
+(0.0030 -0.0165 0.2475)
+(0.0060 -0.0165 0.2475)
+(-0.0060 -0.0135 0.2475)
+(-0.0030 -0.0135 0.2475)
+(0.0000 -0.0135 0.2475)
+(0.0030 -0.0135 0.2475)
+(0.0060 -0.0135 0.2475)
+(-0.0060 -0.0105 0.2475)
+(-0.0030 -0.0105 0.2475)
+(0.0000 -0.0105 0.2475)
+(0.0030 -0.0105 0.2475)
+(0.0060 -0.0105 0.2475)
+(-0.0060 -0.0075 0.2475)
+(-0.0030 -0.0075 0.2475)
+(0.0000 -0.0075 0.2475)
+(0.0030 -0.0075 0.2475)
+(0.0060 -0.0075 0.2475)
+(-0.0060 -0.0045 0.2475)
+(-0.0030 -0.0045 0.2475)
+(0.0000 -0.0045 0.2475)
+(0.0030 -0.0045 0.2475)
+(0.0060 -0.0045 0.2475)
+(-0.0060 -0.0015 0.2475)
+(-0.0030 -0.0015 0.2475)
+(0.0000 -0.0015 0.2475)
+(0.0030 -0.0015 0.2475)
+(0.0060 -0.0015 0.2475)
+(-0.0060 0.0015 0.2475)
+(-0.0030 0.0015 0.2475)
+(0.0000 0.0015 0.2475)
+(0.0030 0.0015 0.2475)
+(0.0060 0.0015 0.2475)
+(-0.0060 0.0045 0.2475)
+(-0.0030 0.0045 0.2475)
+(0.0000 0.0045 0.2475)
+(0.0030 0.0045 0.2475)
+(0.0060 0.0045 0.2475)
+(-0.0060 0.0075 0.2475)
+(-0.0030 0.0075 0.2475)
+(0.0000 0.0075 0.2475)
+(0.0030 0.0075 0.2475)
+(0.0060 0.0075 0.2475)
+(-0.0060 0.0105 0.2475)
+(-0.0030 0.0105 0.2475)
+(0.0000 0.0105 0.2475)
+(0.0030 0.0105 0.2475)
+(0.0060 0.0105 0.2475)
+(-0.0060 0.0135 0.2475)
+(-0.0030 0.0135 0.2475)
+(0.0000 0.0135 0.2475)
+(0.0030 0.0135 0.2475)
+(0.0060 0.0135 0.2475)
+(-0.0060 0.0165 0.2475)
+(-0.0030 0.0165 0.2475)
+(0.0000 0.0165 0.2475)
+(0.0030 0.0165 0.2475)
+(0.0060 0.0165 0.2475)
+(-0.0060 0.0195 0.2475)
+(-0.0030 0.0195 0.2475)
+(0.0000 0.0195 0.2475)
+(0.0030 0.0195 0.2475)
+(0.0060 0.0195 0.2475)
+(-0.0060 0.0225 0.2475)
+(-0.0030 0.0225 0.2475)
+(0.0000 0.0225 0.2475)
+(0.0030 0.0225 0.2475)
+(0.0060 0.0225 0.2475)
+(-0.0060 0.0255 0.2475)
+(-0.0030 0.0255 0.2475)
+(0.0000 0.0255 0.2475)
+(0.0030 0.0255 0.2475)
+(0.0060 0.0255 0.2475)
+(-0.0060 0.0285 0.2475)
+(-0.0030 0.0285 0.2475)
+(0.0000 0.0285 0.2475)
+(0.0030 0.0285 0.2475)
+(0.0060 0.0285 0.2475)
+(-0.0060 0.0315 0.2475)
+(-0.0030 0.0315 0.2475)
+(0.0000 0.0315 0.2475)
+(0.0030 0.0315 0.2475)
+(0.0060 0.0315 0.2475)
+(-0.0060 0.0345 0.2475)
+(-0.0030 0.0345 0.2475)
+(0.0000 0.0345 0.2475)
+(0.0030 0.0345 0.2475)
+(0.0060 0.0345 0.2475)
+(-0.0060 0.0375 0.2475)
+(-0.0030 0.0375 0.2475)
+(0.0000 0.0375 0.2475)
+(0.0030 0.0375 0.2475)
+(0.0060 0.0375 0.2475)
+(-0.0060 0.0405 0.2475)
+(-0.0030 0.0405 0.2475)
+(0.0000 0.0405 0.2475)
+(0.0030 0.0405 0.2475)
+(0.0060 0.0405 0.2475)
+(-0.0060 0.0435 0.2475)
+(-0.0030 0.0435 0.2475)
+(0.0000 0.0435 0.2475)
+(0.0030 0.0435 0.2475)
+(0.0060 0.0435 0.2475)
+(-0.0060 0.0465 0.2475)
+(-0.0030 0.0465 0.2475)
+(0.0000 0.0465 0.2475)
+(0.0030 0.0465 0.2475)
+(0.0060 0.0465 0.2475)
+(-0.0060 0.0495 0.2475)
+(-0.0030 0.0495 0.2475)
+(0.0000 0.0495 0.2475)
+(0.0030 0.0495 0.2475)
+(0.0060 0.0495 0.2475)
+(-0.0060 0.0525 0.2475)
+(-0.0030 0.0525 0.2475)
+(0.0000 0.0525 0.2475)
+(0.0030 0.0525 0.2475)
+(0.0060 0.0525 0.2475)
+(-0.0060 0.0555 0.2475)
+(-0.0030 0.0555 0.2475)
+(0.0000 0.0555 0.2475)
+(0.0030 0.0555 0.2475)
+(0.0060 0.0555 0.2475)
+(-0.0060 0.0585 0.2475)
+(-0.0030 0.0585 0.2475)
+(0.0000 0.0585 0.2475)
+(0.0030 0.0585 0.2475)
+(0.0060 0.0585 0.2475)
+(-0.0060 0.0615 0.2475)
+(-0.0030 0.0615 0.2475)
+(0.0000 0.0615 0.2475)
+(0.0030 0.0615 0.2475)
+(0.0060 0.0615 0.2475)
+(-0.0060 0.0645 0.2475)
+(-0.0030 0.0645 0.2475)
+(0.0000 0.0645 0.2475)
+(0.0030 0.0645 0.2475)
+(0.0060 0.0645 0.2475)
+(-0.0060 0.0675 0.2475)
+(-0.0030 0.0675 0.2475)
+(0.0000 0.0675 0.2475)
+(0.0030 0.0675 0.2475)
+(0.0060 0.0675 0.2475)
+(-0.0060 0.0705 0.2475)
+(-0.0030 0.0705 0.2475)
+(0.0000 0.0705 0.2475)
+(0.0030 0.0705 0.2475)
+(0.0060 0.0705 0.2475)
+(-0.0060 0.0735 0.2475)
+(-0.0030 0.0735 0.2475)
+(0.0000 0.0735 0.2475)
+(0.0030 0.0735 0.2475)
+(0.0060 0.0735 0.2475)
+(-0.0060 -0.0735 0.2505)
+(-0.0030 -0.0735 0.2505)
+(0.0000 -0.0735 0.2505)
+(0.0030 -0.0735 0.2505)
+(0.0060 -0.0735 0.2505)
+(-0.0060 -0.0705 0.2505)
+(-0.0030 -0.0705 0.2505)
+(0.0000 -0.0705 0.2505)
+(0.0030 -0.0705 0.2505)
+(0.0060 -0.0705 0.2505)
+(-0.0060 -0.0675 0.2505)
+(-0.0030 -0.0675 0.2505)
+(0.0000 -0.0675 0.2505)
+(0.0030 -0.0675 0.2505)
+(0.0060 -0.0675 0.2505)
+(-0.0060 -0.0645 0.2505)
+(-0.0030 -0.0645 0.2505)
+(0.0000 -0.0645 0.2505)
+(0.0030 -0.0645 0.2505)
+(0.0060 -0.0645 0.2505)
+(-0.0060 -0.0615 0.2505)
+(-0.0030 -0.0615 0.2505)
+(0.0000 -0.0615 0.2505)
+(0.0030 -0.0615 0.2505)
+(0.0060 -0.0615 0.2505)
+(-0.0060 -0.0585 0.2505)
+(-0.0030 -0.0585 0.2505)
+(0.0000 -0.0585 0.2505)
+(0.0030 -0.0585 0.2505)
+(0.0060 -0.0585 0.2505)
+(-0.0060 -0.0555 0.2505)
+(-0.0030 -0.0555 0.2505)
+(0.0000 -0.0555 0.2505)
+(0.0030 -0.0555 0.2505)
+(0.0060 -0.0555 0.2505)
+(-0.0060 -0.0525 0.2505)
+(-0.0030 -0.0525 0.2505)
+(0.0000 -0.0525 0.2505)
+(0.0030 -0.0525 0.2505)
+(0.0060 -0.0525 0.2505)
+(-0.0060 -0.0495 0.2505)
+(-0.0030 -0.0495 0.2505)
+(0.0000 -0.0495 0.2505)
+(0.0030 -0.0495 0.2505)
+(0.0060 -0.0495 0.2505)
+(-0.0060 -0.0465 0.2505)
+(-0.0030 -0.0465 0.2505)
+(0.0000 -0.0465 0.2505)
+(0.0030 -0.0465 0.2505)
+(0.0060 -0.0465 0.2505)
+(-0.0060 -0.0435 0.2505)
+(-0.0030 -0.0435 0.2505)
+(0.0000 -0.0435 0.2505)
+(0.0030 -0.0435 0.2505)
+(0.0060 -0.0435 0.2505)
+(-0.0060 -0.0405 0.2505)
+(-0.0030 -0.0405 0.2505)
+(0.0000 -0.0405 0.2505)
+(0.0030 -0.0405 0.2505)
+(0.0060 -0.0405 0.2505)
+(-0.0060 -0.0375 0.2505)
+(-0.0030 -0.0375 0.2505)
+(0.0000 -0.0375 0.2505)
+(0.0030 -0.0375 0.2505)
+(0.0060 -0.0375 0.2505)
+(-0.0060 -0.0345 0.2505)
+(-0.0030 -0.0345 0.2505)
+(0.0000 -0.0345 0.2505)
+(0.0030 -0.0345 0.2505)
+(0.0060 -0.0345 0.2505)
+(-0.0060 -0.0315 0.2505)
+(-0.0030 -0.0315 0.2505)
+(0.0000 -0.0315 0.2505)
+(0.0030 -0.0315 0.2505)
+(0.0060 -0.0315 0.2505)
+(-0.0060 -0.0285 0.2505)
+(-0.0030 -0.0285 0.2505)
+(0.0000 -0.0285 0.2505)
+(0.0030 -0.0285 0.2505)
+(0.0060 -0.0285 0.2505)
+(-0.0060 -0.0255 0.2505)
+(-0.0030 -0.0255 0.2505)
+(0.0000 -0.0255 0.2505)
+(0.0030 -0.0255 0.2505)
+(0.0060 -0.0255 0.2505)
+(-0.0060 -0.0225 0.2505)
+(-0.0030 -0.0225 0.2505)
+(0.0000 -0.0225 0.2505)
+(0.0030 -0.0225 0.2505)
+(0.0060 -0.0225 0.2505)
+(-0.0060 -0.0195 0.2505)
+(-0.0030 -0.0195 0.2505)
+(0.0000 -0.0195 0.2505)
+(0.0030 -0.0195 0.2505)
+(0.0060 -0.0195 0.2505)
+(-0.0060 -0.0165 0.2505)
+(-0.0030 -0.0165 0.2505)
+(0.0000 -0.0165 0.2505)
+(0.0030 -0.0165 0.2505)
+(0.0060 -0.0165 0.2505)
+(-0.0060 -0.0135 0.2505)
+(-0.0030 -0.0135 0.2505)
+(0.0000 -0.0135 0.2505)
+(0.0030 -0.0135 0.2505)
+(0.0060 -0.0135 0.2505)
+(-0.0060 -0.0105 0.2505)
+(-0.0030 -0.0105 0.2505)
+(0.0000 -0.0105 0.2505)
+(0.0030 -0.0105 0.2505)
+(0.0060 -0.0105 0.2505)
+(-0.0060 -0.0075 0.2505)
+(-0.0030 -0.0075 0.2505)
+(0.0000 -0.0075 0.2505)
+(0.0030 -0.0075 0.2505)
+(0.0060 -0.0075 0.2505)
+(-0.0060 -0.0045 0.2505)
+(-0.0030 -0.0045 0.2505)
+(0.0000 -0.0045 0.2505)
+(0.0030 -0.0045 0.2505)
+(0.0060 -0.0045 0.2505)
+(-0.0060 -0.0015 0.2505)
+(-0.0030 -0.0015 0.2505)
+(0.0000 -0.0015 0.2505)
+(0.0030 -0.0015 0.2505)
+(0.0060 -0.0015 0.2505)
+(-0.0060 0.0015 0.2505)
+(-0.0030 0.0015 0.2505)
+(0.0000 0.0015 0.2505)
+(0.0030 0.0015 0.2505)
+(0.0060 0.0015 0.2505)
+(-0.0060 0.0045 0.2505)
+(-0.0030 0.0045 0.2505)
+(0.0000 0.0045 0.2505)
+(0.0030 0.0045 0.2505)
+(0.0060 0.0045 0.2505)
+(-0.0060 0.0075 0.2505)
+(-0.0030 0.0075 0.2505)
+(0.0000 0.0075 0.2505)
+(0.0030 0.0075 0.2505)
+(0.0060 0.0075 0.2505)
+(-0.0060 0.0105 0.2505)
+(-0.0030 0.0105 0.2505)
+(0.0000 0.0105 0.2505)
+(0.0030 0.0105 0.2505)
+(0.0060 0.0105 0.2505)
+(-0.0060 0.0135 0.2505)
+(-0.0030 0.0135 0.2505)
+(0.0000 0.0135 0.2505)
+(0.0030 0.0135 0.2505)
+(0.0060 0.0135 0.2505)
+(-0.0060 0.0165 0.2505)
+(-0.0030 0.0165 0.2505)
+(0.0000 0.0165 0.2505)
+(0.0030 0.0165 0.2505)
+(0.0060 0.0165 0.2505)
+(-0.0060 0.0195 0.2505)
+(-0.0030 0.0195 0.2505)
+(0.0000 0.0195 0.2505)
+(0.0030 0.0195 0.2505)
+(0.0060 0.0195 0.2505)
+(-0.0060 0.0225 0.2505)
+(-0.0030 0.0225 0.2505)
+(0.0000 0.0225 0.2505)
+(0.0030 0.0225 0.2505)
+(0.0060 0.0225 0.2505)
+(-0.0060 0.0255 0.2505)
+(-0.0030 0.0255 0.2505)
+(0.0000 0.0255 0.2505)
+(0.0030 0.0255 0.2505)
+(0.0060 0.0255 0.2505)
+(-0.0060 0.0285 0.2505)
+(-0.0030 0.0285 0.2505)
+(0.0000 0.0285 0.2505)
+(0.0030 0.0285 0.2505)
+(0.0060 0.0285 0.2505)
+(-0.0060 0.0315 0.2505)
+(-0.0030 0.0315 0.2505)
+(0.0000 0.0315 0.2505)
+(0.0030 0.0315 0.2505)
+(0.0060 0.0315 0.2505)
+(-0.0060 0.0345 0.2505)
+(-0.0030 0.0345 0.2505)
+(0.0000 0.0345 0.2505)
+(0.0030 0.0345 0.2505)
+(0.0060 0.0345 0.2505)
+(-0.0060 0.0375 0.2505)
+(-0.0030 0.0375 0.2505)
+(0.0000 0.0375 0.2505)
+(0.0030 0.0375 0.2505)
+(0.0060 0.0375 0.2505)
+(-0.0060 0.0405 0.2505)
+(-0.0030 0.0405 0.2505)
+(0.0000 0.0405 0.2505)
+(0.0030 0.0405 0.2505)
+(0.0060 0.0405 0.2505)
+(-0.0060 0.0435 0.2505)
+(-0.0030 0.0435 0.2505)
+(0.0000 0.0435 0.2505)
+(0.0030 0.0435 0.2505)
+(0.0060 0.0435 0.2505)
+(-0.0060 0.0465 0.2505)
+(-0.0030 0.0465 0.2505)
+(0.0000 0.0465 0.2505)
+(0.0030 0.0465 0.2505)
+(0.0060 0.0465 0.2505)
+(-0.0060 0.0495 0.2505)
+(-0.0030 0.0495 0.2505)
+(0.0000 0.0495 0.2505)
+(0.0030 0.0495 0.2505)
+(0.0060 0.0495 0.2505)
+(-0.0060 0.0525 0.2505)
+(-0.0030 0.0525 0.2505)
+(0.0000 0.0525 0.2505)
+(0.0030 0.0525 0.2505)
+(0.0060 0.0525 0.2505)
+(-0.0060 0.0555 0.2505)
+(-0.0030 0.0555 0.2505)
+(0.0000 0.0555 0.2505)
+(0.0030 0.0555 0.2505)
+(0.0060 0.0555 0.2505)
+(-0.0060 0.0585 0.2505)
+(-0.0030 0.0585 0.2505)
+(0.0000 0.0585 0.2505)
+(0.0030 0.0585 0.2505)
+(0.0060 0.0585 0.2505)
+(-0.0060 0.0615 0.2505)
+(-0.0030 0.0615 0.2505)
+(0.0000 0.0615 0.2505)
+(0.0030 0.0615 0.2505)
+(0.0060 0.0615 0.2505)
+(-0.0060 0.0645 0.2505)
+(-0.0030 0.0645 0.2505)
+(0.0000 0.0645 0.2505)
+(0.0030 0.0645 0.2505)
+(0.0060 0.0645 0.2505)
+(-0.0060 0.0675 0.2505)
+(-0.0030 0.0675 0.2505)
+(0.0000 0.0675 0.2505)
+(0.0030 0.0675 0.2505)
+(0.0060 0.0675 0.2505)
+(-0.0060 0.0705 0.2505)
+(-0.0030 0.0705 0.2505)
+(0.0000 0.0705 0.2505)
+(0.0030 0.0705 0.2505)
+(0.0060 0.0705 0.2505)
+(-0.0060 0.0735 0.2505)
+(-0.0030 0.0735 0.2505)
+(0.0000 0.0735 0.2505)
+(0.0030 0.0735 0.2505)
+(0.0060 0.0735 0.2505)
+(-0.0060 -0.0735 0.2535)
+(-0.0030 -0.0735 0.2535)
+(0.0000 -0.0735 0.2535)
+(0.0030 -0.0735 0.2535)
+(0.0060 -0.0735 0.2535)
+(-0.0060 -0.0705 0.2535)
+(-0.0030 -0.0705 0.2535)
+(0.0000 -0.0705 0.2535)
+(0.0030 -0.0705 0.2535)
+(0.0060 -0.0705 0.2535)
+(-0.0060 -0.0675 0.2535)
+(-0.0030 -0.0675 0.2535)
+(0.0000 -0.0675 0.2535)
+(0.0030 -0.0675 0.2535)
+(0.0060 -0.0675 0.2535)
+(-0.0060 -0.0645 0.2535)
+(-0.0030 -0.0645 0.2535)
+(0.0000 -0.0645 0.2535)
+(0.0030 -0.0645 0.2535)
+(0.0060 -0.0645 0.2535)
+(-0.0060 -0.0615 0.2535)
+(-0.0030 -0.0615 0.2535)
+(0.0000 -0.0615 0.2535)
+(0.0030 -0.0615 0.2535)
+(0.0060 -0.0615 0.2535)
+(-0.0060 -0.0585 0.2535)
+(-0.0030 -0.0585 0.2535)
+(0.0000 -0.0585 0.2535)
+(0.0030 -0.0585 0.2535)
+(0.0060 -0.0585 0.2535)
+(-0.0060 -0.0555 0.2535)
+(-0.0030 -0.0555 0.2535)
+(0.0000 -0.0555 0.2535)
+(0.0030 -0.0555 0.2535)
+(0.0060 -0.0555 0.2535)
+(-0.0060 -0.0525 0.2535)
+(-0.0030 -0.0525 0.2535)
+(0.0000 -0.0525 0.2535)
+(0.0030 -0.0525 0.2535)
+(0.0060 -0.0525 0.2535)
+(-0.0060 -0.0495 0.2535)
+(-0.0030 -0.0495 0.2535)
+(0.0000 -0.0495 0.2535)
+(0.0030 -0.0495 0.2535)
+(0.0060 -0.0495 0.2535)
+(-0.0060 -0.0465 0.2535)
+(-0.0030 -0.0465 0.2535)
+(0.0000 -0.0465 0.2535)
+(0.0030 -0.0465 0.2535)
+(0.0060 -0.0465 0.2535)
+(-0.0060 -0.0435 0.2535)
+(-0.0030 -0.0435 0.2535)
+(0.0000 -0.0435 0.2535)
+(0.0030 -0.0435 0.2535)
+(0.0060 -0.0435 0.2535)
+(-0.0060 -0.0405 0.2535)
+(-0.0030 -0.0405 0.2535)
+(0.0000 -0.0405 0.2535)
+(0.0030 -0.0405 0.2535)
+(0.0060 -0.0405 0.2535)
+(-0.0060 -0.0375 0.2535)
+(-0.0030 -0.0375 0.2535)
+(0.0000 -0.0375 0.2535)
+(0.0030 -0.0375 0.2535)
+(0.0060 -0.0375 0.2535)
+(-0.0060 -0.0345 0.2535)
+(-0.0030 -0.0345 0.2535)
+(0.0000 -0.0345 0.2535)
+(0.0030 -0.0345 0.2535)
+(0.0060 -0.0345 0.2535)
+(-0.0060 -0.0315 0.2535)
+(-0.0030 -0.0315 0.2535)
+(0.0000 -0.0315 0.2535)
+(0.0030 -0.0315 0.2535)
+(0.0060 -0.0315 0.2535)
+(-0.0060 -0.0285 0.2535)
+(-0.0030 -0.0285 0.2535)
+(0.0000 -0.0285 0.2535)
+(0.0030 -0.0285 0.2535)
+(0.0060 -0.0285 0.2535)
+(-0.0060 -0.0255 0.2535)
+(-0.0030 -0.0255 0.2535)
+(0.0000 -0.0255 0.2535)
+(0.0030 -0.0255 0.2535)
+(0.0060 -0.0255 0.2535)
+(-0.0060 -0.0225 0.2535)
+(-0.0030 -0.0225 0.2535)
+(0.0000 -0.0225 0.2535)
+(0.0030 -0.0225 0.2535)
+(0.0060 -0.0225 0.2535)
+(-0.0060 -0.0195 0.2535)
+(-0.0030 -0.0195 0.2535)
+(0.0000 -0.0195 0.2535)
+(0.0030 -0.0195 0.2535)
+(0.0060 -0.0195 0.2535)
+(-0.0060 -0.0165 0.2535)
+(-0.0030 -0.0165 0.2535)
+(0.0000 -0.0165 0.2535)
+(0.0030 -0.0165 0.2535)
+(0.0060 -0.0165 0.2535)
+(-0.0060 -0.0135 0.2535)
+(-0.0030 -0.0135 0.2535)
+(0.0000 -0.0135 0.2535)
+(0.0030 -0.0135 0.2535)
+(0.0060 -0.0135 0.2535)
+(-0.0060 -0.0105 0.2535)
+(-0.0030 -0.0105 0.2535)
+(0.0000 -0.0105 0.2535)
+(0.0030 -0.0105 0.2535)
+(0.0060 -0.0105 0.2535)
+(-0.0060 -0.0075 0.2535)
+(-0.0030 -0.0075 0.2535)
+(0.0000 -0.0075 0.2535)
+(0.0030 -0.0075 0.2535)
+(0.0060 -0.0075 0.2535)
+(-0.0060 -0.0045 0.2535)
+(-0.0030 -0.0045 0.2535)
+(0.0000 -0.0045 0.2535)
+(0.0030 -0.0045 0.2535)
+(0.0060 -0.0045 0.2535)
+(-0.0060 -0.0015 0.2535)
+(-0.0030 -0.0015 0.2535)
+(0.0000 -0.0015 0.2535)
+(0.0030 -0.0015 0.2535)
+(0.0060 -0.0015 0.2535)
+(-0.0060 0.0015 0.2535)
+(-0.0030 0.0015 0.2535)
+(0.0000 0.0015 0.2535)
+(0.0030 0.0015 0.2535)
+(0.0060 0.0015 0.2535)
+(-0.0060 0.0045 0.2535)
+(-0.0030 0.0045 0.2535)
+(0.0000 0.0045 0.2535)
+(0.0030 0.0045 0.2535)
+(0.0060 0.0045 0.2535)
+(-0.0060 0.0075 0.2535)
+(-0.0030 0.0075 0.2535)
+(0.0000 0.0075 0.2535)
+(0.0030 0.0075 0.2535)
+(0.0060 0.0075 0.2535)
+(-0.0060 0.0105 0.2535)
+(-0.0030 0.0105 0.2535)
+(0.0000 0.0105 0.2535)
+(0.0030 0.0105 0.2535)
+(0.0060 0.0105 0.2535)
+(-0.0060 0.0135 0.2535)
+(-0.0030 0.0135 0.2535)
+(0.0000 0.0135 0.2535)
+(0.0030 0.0135 0.2535)
+(0.0060 0.0135 0.2535)
+(-0.0060 0.0165 0.2535)
+(-0.0030 0.0165 0.2535)
+(0.0000 0.0165 0.2535)
+(0.0030 0.0165 0.2535)
+(0.0060 0.0165 0.2535)
+(-0.0060 0.0195 0.2535)
+(-0.0030 0.0195 0.2535)
+(0.0000 0.0195 0.2535)
+(0.0030 0.0195 0.2535)
+(0.0060 0.0195 0.2535)
+(-0.0060 0.0225 0.2535)
+(-0.0030 0.0225 0.2535)
+(0.0000 0.0225 0.2535)
+(0.0030 0.0225 0.2535)
+(0.0060 0.0225 0.2535)
+(-0.0060 0.0255 0.2535)
+(-0.0030 0.0255 0.2535)
+(0.0000 0.0255 0.2535)
+(0.0030 0.0255 0.2535)
+(0.0060 0.0255 0.2535)
+(-0.0060 0.0285 0.2535)
+(-0.0030 0.0285 0.2535)
+(0.0000 0.0285 0.2535)
+(0.0030 0.0285 0.2535)
+(0.0060 0.0285 0.2535)
+(-0.0060 0.0315 0.2535)
+(-0.0030 0.0315 0.2535)
+(0.0000 0.0315 0.2535)
+(0.0030 0.0315 0.2535)
+(0.0060 0.0315 0.2535)
+(-0.0060 0.0345 0.2535)
+(-0.0030 0.0345 0.2535)
+(0.0000 0.0345 0.2535)
+(0.0030 0.0345 0.2535)
+(0.0060 0.0345 0.2535)
+(-0.0060 0.0375 0.2535)
+(-0.0030 0.0375 0.2535)
+(0.0000 0.0375 0.2535)
+(0.0030 0.0375 0.2535)
+(0.0060 0.0375 0.2535)
+(-0.0060 0.0405 0.2535)
+(-0.0030 0.0405 0.2535)
+(0.0000 0.0405 0.2535)
+(0.0030 0.0405 0.2535)
+(0.0060 0.0405 0.2535)
+(-0.0060 0.0435 0.2535)
+(-0.0030 0.0435 0.2535)
+(0.0000 0.0435 0.2535)
+(0.0030 0.0435 0.2535)
+(0.0060 0.0435 0.2535)
+(-0.0060 0.0465 0.2535)
+(-0.0030 0.0465 0.2535)
+(0.0000 0.0465 0.2535)
+(0.0030 0.0465 0.2535)
+(0.0060 0.0465 0.2535)
+(-0.0060 0.0495 0.2535)
+(-0.0030 0.0495 0.2535)
+(0.0000 0.0495 0.2535)
+(0.0030 0.0495 0.2535)
+(0.0060 0.0495 0.2535)
+(-0.0060 0.0525 0.2535)
+(-0.0030 0.0525 0.2535)
+(0.0000 0.0525 0.2535)
+(0.0030 0.0525 0.2535)
+(0.0060 0.0525 0.2535)
+(-0.0060 0.0555 0.2535)
+(-0.0030 0.0555 0.2535)
+(0.0000 0.0555 0.2535)
+(0.0030 0.0555 0.2535)
+(0.0060 0.0555 0.2535)
+(-0.0060 0.0585 0.2535)
+(-0.0030 0.0585 0.2535)
+(0.0000 0.0585 0.2535)
+(0.0030 0.0585 0.2535)
+(0.0060 0.0585 0.2535)
+(-0.0060 0.0615 0.2535)
+(-0.0030 0.0615 0.2535)
+(0.0000 0.0615 0.2535)
+(0.0030 0.0615 0.2535)
+(0.0060 0.0615 0.2535)
+(-0.0060 0.0645 0.2535)
+(-0.0030 0.0645 0.2535)
+(0.0000 0.0645 0.2535)
+(0.0030 0.0645 0.2535)
+(0.0060 0.0645 0.2535)
+(-0.0060 0.0675 0.2535)
+(-0.0030 0.0675 0.2535)
+(0.0000 0.0675 0.2535)
+(0.0030 0.0675 0.2535)
+(0.0060 0.0675 0.2535)
+(-0.0060 0.0705 0.2535)
+(-0.0030 0.0705 0.2535)
+(0.0000 0.0705 0.2535)
+(0.0030 0.0705 0.2535)
+(0.0060 0.0705 0.2535)
+(-0.0060 0.0735 0.2535)
+(-0.0030 0.0735 0.2535)
+(0.0000 0.0735 0.2535)
+(0.0030 0.0735 0.2535)
+(0.0060 0.0735 0.2535)
+(-0.0060 -0.0735 0.2565)
+(-0.0030 -0.0735 0.2565)
+(0.0000 -0.0735 0.2565)
+(0.0030 -0.0735 0.2565)
+(0.0060 -0.0735 0.2565)
+(-0.0060 -0.0705 0.2565)
+(-0.0030 -0.0705 0.2565)
+(0.0000 -0.0705 0.2565)
+(0.0030 -0.0705 0.2565)
+(0.0060 -0.0705 0.2565)
+(-0.0060 -0.0675 0.2565)
+(-0.0030 -0.0675 0.2565)
+(0.0000 -0.0675 0.2565)
+(0.0030 -0.0675 0.2565)
+(0.0060 -0.0675 0.2565)
+(-0.0060 -0.0645 0.2565)
+(-0.0030 -0.0645 0.2565)
+(0.0000 -0.0645 0.2565)
+(0.0030 -0.0645 0.2565)
+(0.0060 -0.0645 0.2565)
+(-0.0060 -0.0615 0.2565)
+(-0.0030 -0.0615 0.2565)
+(0.0000 -0.0615 0.2565)
+(0.0030 -0.0615 0.2565)
+(0.0060 -0.0615 0.2565)
+(-0.0060 -0.0585 0.2565)
+(-0.0030 -0.0585 0.2565)
+(0.0000 -0.0585 0.2565)
+(0.0030 -0.0585 0.2565)
+(0.0060 -0.0585 0.2565)
+(-0.0060 -0.0555 0.2565)
+(-0.0030 -0.0555 0.2565)
+(0.0000 -0.0555 0.2565)
+(0.0030 -0.0555 0.2565)
+(0.0060 -0.0555 0.2565)
+(-0.0060 -0.0525 0.2565)
+(-0.0030 -0.0525 0.2565)
+(0.0000 -0.0525 0.2565)
+(0.0030 -0.0525 0.2565)
+(0.0060 -0.0525 0.2565)
+(-0.0060 -0.0495 0.2565)
+(-0.0030 -0.0495 0.2565)
+(0.0000 -0.0495 0.2565)
+(0.0030 -0.0495 0.2565)
+(0.0060 -0.0495 0.2565)
+(-0.0060 -0.0465 0.2565)
+(-0.0030 -0.0465 0.2565)
+(0.0000 -0.0465 0.2565)
+(0.0030 -0.0465 0.2565)
+(0.0060 -0.0465 0.2565)
+(-0.0060 -0.0435 0.2565)
+(-0.0030 -0.0435 0.2565)
+(0.0000 -0.0435 0.2565)
+(0.0030 -0.0435 0.2565)
+(0.0060 -0.0435 0.2565)
+(-0.0060 -0.0405 0.2565)
+(-0.0030 -0.0405 0.2565)
+(0.0000 -0.0405 0.2565)
+(0.0030 -0.0405 0.2565)
+(0.0060 -0.0405 0.2565)
+(-0.0060 -0.0375 0.2565)
+(-0.0030 -0.0375 0.2565)
+(0.0000 -0.0375 0.2565)
+(0.0030 -0.0375 0.2565)
+(0.0060 -0.0375 0.2565)
+(-0.0060 -0.0345 0.2565)
+(-0.0030 -0.0345 0.2565)
+(0.0000 -0.0345 0.2565)
+(0.0030 -0.0345 0.2565)
+(0.0060 -0.0345 0.2565)
+(-0.0060 -0.0315 0.2565)
+(-0.0030 -0.0315 0.2565)
+(0.0000 -0.0315 0.2565)
+(0.0030 -0.0315 0.2565)
+(0.0060 -0.0315 0.2565)
+(-0.0060 -0.0285 0.2565)
+(-0.0030 -0.0285 0.2565)
+(0.0000 -0.0285 0.2565)
+(0.0030 -0.0285 0.2565)
+(0.0060 -0.0285 0.2565)
+(-0.0060 -0.0255 0.2565)
+(-0.0030 -0.0255 0.2565)
+(0.0000 -0.0255 0.2565)
+(0.0030 -0.0255 0.2565)
+(0.0060 -0.0255 0.2565)
+(-0.0060 -0.0225 0.2565)
+(-0.0030 -0.0225 0.2565)
+(0.0000 -0.0225 0.2565)
+(0.0030 -0.0225 0.2565)
+(0.0060 -0.0225 0.2565)
+(-0.0060 -0.0195 0.2565)
+(-0.0030 -0.0195 0.2565)
+(0.0000 -0.0195 0.2565)
+(0.0030 -0.0195 0.2565)
+(0.0060 -0.0195 0.2565)
+(-0.0060 -0.0165 0.2565)
+(-0.0030 -0.0165 0.2565)
+(0.0000 -0.0165 0.2565)
+(0.0030 -0.0165 0.2565)
+(0.0060 -0.0165 0.2565)
+(-0.0060 -0.0135 0.2565)
+(-0.0030 -0.0135 0.2565)
+(0.0000 -0.0135 0.2565)
+(0.0030 -0.0135 0.2565)
+(0.0060 -0.0135 0.2565)
+(-0.0060 -0.0105 0.2565)
+(-0.0030 -0.0105 0.2565)
+(0.0000 -0.0105 0.2565)
+(0.0030 -0.0105 0.2565)
+(0.0060 -0.0105 0.2565)
+(-0.0060 -0.0075 0.2565)
+(-0.0030 -0.0075 0.2565)
+(0.0000 -0.0075 0.2565)
+(0.0030 -0.0075 0.2565)
+(0.0060 -0.0075 0.2565)
+(-0.0060 -0.0045 0.2565)
+(-0.0030 -0.0045 0.2565)
+(0.0000 -0.0045 0.2565)
+(0.0030 -0.0045 0.2565)
+(0.0060 -0.0045 0.2565)
+(-0.0060 -0.0015 0.2565)
+(-0.0030 -0.0015 0.2565)
+(0.0000 -0.0015 0.2565)
+(0.0030 -0.0015 0.2565)
+(0.0060 -0.0015 0.2565)
+(-0.0060 0.0015 0.2565)
+(-0.0030 0.0015 0.2565)
+(0.0000 0.0015 0.2565)
+(0.0030 0.0015 0.2565)
+(0.0060 0.0015 0.2565)
+(-0.0060 0.0045 0.2565)
+(-0.0030 0.0045 0.2565)
+(0.0000 0.0045 0.2565)
+(0.0030 0.0045 0.2565)
+(0.0060 0.0045 0.2565)
+(-0.0060 0.0075 0.2565)
+(-0.0030 0.0075 0.2565)
+(0.0000 0.0075 0.2565)
+(0.0030 0.0075 0.2565)
+(0.0060 0.0075 0.2565)
+(-0.0060 0.0105 0.2565)
+(-0.0030 0.0105 0.2565)
+(0.0000 0.0105 0.2565)
+(0.0030 0.0105 0.2565)
+(0.0060 0.0105 0.2565)
+(-0.0060 0.0135 0.2565)
+(-0.0030 0.0135 0.2565)
+(0.0000 0.0135 0.2565)
+(0.0030 0.0135 0.2565)
+(0.0060 0.0135 0.2565)
+(-0.0060 0.0165 0.2565)
+(-0.0030 0.0165 0.2565)
+(0.0000 0.0165 0.2565)
+(0.0030 0.0165 0.2565)
+(0.0060 0.0165 0.2565)
+(-0.0060 0.0195 0.2565)
+(-0.0030 0.0195 0.2565)
+(0.0000 0.0195 0.2565)
+(0.0030 0.0195 0.2565)
+(0.0060 0.0195 0.2565)
+(-0.0060 0.0225 0.2565)
+(-0.0030 0.0225 0.2565)
+(0.0000 0.0225 0.2565)
+(0.0030 0.0225 0.2565)
+(0.0060 0.0225 0.2565)
+(-0.0060 0.0255 0.2565)
+(-0.0030 0.0255 0.2565)
+(0.0000 0.0255 0.2565)
+(0.0030 0.0255 0.2565)
+(0.0060 0.0255 0.2565)
+(-0.0060 0.0285 0.2565)
+(-0.0030 0.0285 0.2565)
+(0.0000 0.0285 0.2565)
+(0.0030 0.0285 0.2565)
+(0.0060 0.0285 0.2565)
+(-0.0060 0.0315 0.2565)
+(-0.0030 0.0315 0.2565)
+(0.0000 0.0315 0.2565)
+(0.0030 0.0315 0.2565)
+(0.0060 0.0315 0.2565)
+(-0.0060 0.0345 0.2565)
+(-0.0030 0.0345 0.2565)
+(0.0000 0.0345 0.2565)
+(0.0030 0.0345 0.2565)
+(0.0060 0.0345 0.2565)
+(-0.0060 0.0375 0.2565)
+(-0.0030 0.0375 0.2565)
+(0.0000 0.0375 0.2565)
+(0.0030 0.0375 0.2565)
+(0.0060 0.0375 0.2565)
+(-0.0060 0.0405 0.2565)
+(-0.0030 0.0405 0.2565)
+(0.0000 0.0405 0.2565)
+(0.0030 0.0405 0.2565)
+(0.0060 0.0405 0.2565)
+(-0.0060 0.0435 0.2565)
+(-0.0030 0.0435 0.2565)
+(0.0000 0.0435 0.2565)
+(0.0030 0.0435 0.2565)
+(0.0060 0.0435 0.2565)
+(-0.0060 0.0465 0.2565)
+(-0.0030 0.0465 0.2565)
+(0.0000 0.0465 0.2565)
+(0.0030 0.0465 0.2565)
+(0.0060 0.0465 0.2565)
+(-0.0060 0.0495 0.2565)
+(-0.0030 0.0495 0.2565)
+(0.0000 0.0495 0.2565)
+(0.0030 0.0495 0.2565)
+(0.0060 0.0495 0.2565)
+(-0.0060 0.0525 0.2565)
+(-0.0030 0.0525 0.2565)
+(0.0000 0.0525 0.2565)
+(0.0030 0.0525 0.2565)
+(0.0060 0.0525 0.2565)
+(-0.0060 0.0555 0.2565)
+(-0.0030 0.0555 0.2565)
+(0.0000 0.0555 0.2565)
+(0.0030 0.0555 0.2565)
+(0.0060 0.0555 0.2565)
+(-0.0060 0.0585 0.2565)
+(-0.0030 0.0585 0.2565)
+(0.0000 0.0585 0.2565)
+(0.0030 0.0585 0.2565)
+(0.0060 0.0585 0.2565)
+(-0.0060 0.0615 0.2565)
+(-0.0030 0.0615 0.2565)
+(0.0000 0.0615 0.2565)
+(0.0030 0.0615 0.2565)
+(0.0060 0.0615 0.2565)
+(-0.0060 0.0645 0.2565)
+(-0.0030 0.0645 0.2565)
+(0.0000 0.0645 0.2565)
+(0.0030 0.0645 0.2565)
+(0.0060 0.0645 0.2565)
+(-0.0060 0.0675 0.2565)
+(-0.0030 0.0675 0.2565)
+(0.0000 0.0675 0.2565)
+(0.0030 0.0675 0.2565)
+(0.0060 0.0675 0.2565)
+(-0.0060 0.0705 0.2565)
+(-0.0030 0.0705 0.2565)
+(0.0000 0.0705 0.2565)
+(0.0030 0.0705 0.2565)
+(0.0060 0.0705 0.2565)
+(-0.0060 0.0735 0.2565)
+(-0.0030 0.0735 0.2565)
+(0.0000 0.0735 0.2565)
+(0.0030 0.0735 0.2565)
+(0.0060 0.0735 0.2565)
+(-0.0060 -0.0735 0.2595)
+(-0.0030 -0.0735 0.2595)
+(0.0000 -0.0735 0.2595)
+(0.0030 -0.0735 0.2595)
+(0.0060 -0.0735 0.2595)
+(-0.0060 -0.0705 0.2595)
+(-0.0030 -0.0705 0.2595)
+(0.0000 -0.0705 0.2595)
+(0.0030 -0.0705 0.2595)
+(0.0060 -0.0705 0.2595)
+(-0.0060 -0.0675 0.2595)
+(-0.0030 -0.0675 0.2595)
+(0.0000 -0.0675 0.2595)
+(0.0030 -0.0675 0.2595)
+(0.0060 -0.0675 0.2595)
+(-0.0060 -0.0645 0.2595)
+(-0.0030 -0.0645 0.2595)
+(0.0000 -0.0645 0.2595)
+(0.0030 -0.0645 0.2595)
+(0.0060 -0.0645 0.2595)
+(-0.0060 -0.0615 0.2595)
+(-0.0030 -0.0615 0.2595)
+(0.0000 -0.0615 0.2595)
+(0.0030 -0.0615 0.2595)
+(0.0060 -0.0615 0.2595)
+(-0.0060 -0.0585 0.2595)
+(-0.0030 -0.0585 0.2595)
+(0.0000 -0.0585 0.2595)
+(0.0030 -0.0585 0.2595)
+(0.0060 -0.0585 0.2595)
+(-0.0060 -0.0555 0.2595)
+(-0.0030 -0.0555 0.2595)
+(0.0000 -0.0555 0.2595)
+(0.0030 -0.0555 0.2595)
+(0.0060 -0.0555 0.2595)
+(-0.0060 -0.0525 0.2595)
+(-0.0030 -0.0525 0.2595)
+(0.0000 -0.0525 0.2595)
+(0.0030 -0.0525 0.2595)
+(0.0060 -0.0525 0.2595)
+(-0.0060 -0.0495 0.2595)
+(-0.0030 -0.0495 0.2595)
+(0.0000 -0.0495 0.2595)
+(0.0030 -0.0495 0.2595)
+(0.0060 -0.0495 0.2595)
+(-0.0060 -0.0465 0.2595)
+(-0.0030 -0.0465 0.2595)
+(0.0000 -0.0465 0.2595)
+(0.0030 -0.0465 0.2595)
+(0.0060 -0.0465 0.2595)
+(-0.0060 -0.0435 0.2595)
+(-0.0030 -0.0435 0.2595)
+(0.0000 -0.0435 0.2595)
+(0.0030 -0.0435 0.2595)
+(0.0060 -0.0435 0.2595)
+(-0.0060 -0.0405 0.2595)
+(-0.0030 -0.0405 0.2595)
+(0.0000 -0.0405 0.2595)
+(0.0030 -0.0405 0.2595)
+(0.0060 -0.0405 0.2595)
+(-0.0060 -0.0375 0.2595)
+(-0.0030 -0.0375 0.2595)
+(0.0000 -0.0375 0.2595)
+(0.0030 -0.0375 0.2595)
+(0.0060 -0.0375 0.2595)
+(-0.0060 -0.0345 0.2595)
+(-0.0030 -0.0345 0.2595)
+(0.0000 -0.0345 0.2595)
+(0.0030 -0.0345 0.2595)
+(0.0060 -0.0345 0.2595)
+(-0.0060 -0.0315 0.2595)
+(-0.0030 -0.0315 0.2595)
+(0.0000 -0.0315 0.2595)
+(0.0030 -0.0315 0.2595)
+(0.0060 -0.0315 0.2595)
+(-0.0060 -0.0285 0.2595)
+(-0.0030 -0.0285 0.2595)
+(0.0000 -0.0285 0.2595)
+(0.0030 -0.0285 0.2595)
+(0.0060 -0.0285 0.2595)
+(-0.0060 -0.0255 0.2595)
+(-0.0030 -0.0255 0.2595)
+(0.0000 -0.0255 0.2595)
+(0.0030 -0.0255 0.2595)
+(0.0060 -0.0255 0.2595)
+(-0.0060 -0.0225 0.2595)
+(-0.0030 -0.0225 0.2595)
+(0.0000 -0.0225 0.2595)
+(0.0030 -0.0225 0.2595)
+(0.0060 -0.0225 0.2595)
+(-0.0060 -0.0195 0.2595)
+(-0.0030 -0.0195 0.2595)
+(0.0000 -0.0195 0.2595)
+(0.0030 -0.0195 0.2595)
+(0.0060 -0.0195 0.2595)
+(-0.0060 -0.0165 0.2595)
+(-0.0030 -0.0165 0.2595)
+(0.0000 -0.0165 0.2595)
+(0.0030 -0.0165 0.2595)
+(0.0060 -0.0165 0.2595)
+(-0.0060 -0.0135 0.2595)
+(-0.0030 -0.0135 0.2595)
+(0.0000 -0.0135 0.2595)
+(0.0030 -0.0135 0.2595)
+(0.0060 -0.0135 0.2595)
+(-0.0060 -0.0105 0.2595)
+(-0.0030 -0.0105 0.2595)
+(0.0000 -0.0105 0.2595)
+(0.0030 -0.0105 0.2595)
+(0.0060 -0.0105 0.2595)
+(-0.0060 -0.0075 0.2595)
+(-0.0030 -0.0075 0.2595)
+(0.0000 -0.0075 0.2595)
+(0.0030 -0.0075 0.2595)
+(0.0060 -0.0075 0.2595)
+(-0.0060 -0.0045 0.2595)
+(-0.0030 -0.0045 0.2595)
+(0.0000 -0.0045 0.2595)
+(0.0030 -0.0045 0.2595)
+(0.0060 -0.0045 0.2595)
+(-0.0060 -0.0015 0.2595)
+(-0.0030 -0.0015 0.2595)
+(0.0000 -0.0015 0.2595)
+(0.0030 -0.0015 0.2595)
+(0.0060 -0.0015 0.2595)
+(-0.0060 0.0015 0.2595)
+(-0.0030 0.0015 0.2595)
+(0.0000 0.0015 0.2595)
+(0.0030 0.0015 0.2595)
+(0.0060 0.0015 0.2595)
+(-0.0060 0.0045 0.2595)
+(-0.0030 0.0045 0.2595)
+(0.0000 0.0045 0.2595)
+(0.0030 0.0045 0.2595)
+(0.0060 0.0045 0.2595)
+(-0.0060 0.0075 0.2595)
+(-0.0030 0.0075 0.2595)
+(0.0000 0.0075 0.2595)
+(0.0030 0.0075 0.2595)
+(0.0060 0.0075 0.2595)
+(-0.0060 0.0105 0.2595)
+(-0.0030 0.0105 0.2595)
+(0.0000 0.0105 0.2595)
+(0.0030 0.0105 0.2595)
+(0.0060 0.0105 0.2595)
+(-0.0060 0.0135 0.2595)
+(-0.0030 0.0135 0.2595)
+(0.0000 0.0135 0.2595)
+(0.0030 0.0135 0.2595)
+(0.0060 0.0135 0.2595)
+(-0.0060 0.0165 0.2595)
+(-0.0030 0.0165 0.2595)
+(0.0000 0.0165 0.2595)
+(0.0030 0.0165 0.2595)
+(0.0060 0.0165 0.2595)
+(-0.0060 0.0195 0.2595)
+(-0.0030 0.0195 0.2595)
+(0.0000 0.0195 0.2595)
+(0.0030 0.0195 0.2595)
+(0.0060 0.0195 0.2595)
+(-0.0060 0.0225 0.2595)
+(-0.0030 0.0225 0.2595)
+(0.0000 0.0225 0.2595)
+(0.0030 0.0225 0.2595)
+(0.0060 0.0225 0.2595)
+(-0.0060 0.0255 0.2595)
+(-0.0030 0.0255 0.2595)
+(0.0000 0.0255 0.2595)
+(0.0030 0.0255 0.2595)
+(0.0060 0.0255 0.2595)
+(-0.0060 0.0285 0.2595)
+(-0.0030 0.0285 0.2595)
+(0.0000 0.0285 0.2595)
+(0.0030 0.0285 0.2595)
+(0.0060 0.0285 0.2595)
+(-0.0060 0.0315 0.2595)
+(-0.0030 0.0315 0.2595)
+(0.0000 0.0315 0.2595)
+(0.0030 0.0315 0.2595)
+(0.0060 0.0315 0.2595)
+(-0.0060 0.0345 0.2595)
+(-0.0030 0.0345 0.2595)
+(0.0000 0.0345 0.2595)
+(0.0030 0.0345 0.2595)
+(0.0060 0.0345 0.2595)
+(-0.0060 0.0375 0.2595)
+(-0.0030 0.0375 0.2595)
+(0.0000 0.0375 0.2595)
+(0.0030 0.0375 0.2595)
+(0.0060 0.0375 0.2595)
+(-0.0060 0.0405 0.2595)
+(-0.0030 0.0405 0.2595)
+(0.0000 0.0405 0.2595)
+(0.0030 0.0405 0.2595)
+(0.0060 0.0405 0.2595)
+(-0.0060 0.0435 0.2595)
+(-0.0030 0.0435 0.2595)
+(0.0000 0.0435 0.2595)
+(0.0030 0.0435 0.2595)
+(0.0060 0.0435 0.2595)
+(-0.0060 0.0465 0.2595)
+(-0.0030 0.0465 0.2595)
+(0.0000 0.0465 0.2595)
+(0.0030 0.0465 0.2595)
+(0.0060 0.0465 0.2595)
+(-0.0060 0.0495 0.2595)
+(-0.0030 0.0495 0.2595)
+(0.0000 0.0495 0.2595)
+(0.0030 0.0495 0.2595)
+(0.0060 0.0495 0.2595)
+(-0.0060 0.0525 0.2595)
+(-0.0030 0.0525 0.2595)
+(0.0000 0.0525 0.2595)
+(0.0030 0.0525 0.2595)
+(0.0060 0.0525 0.2595)
+(-0.0060 0.0555 0.2595)
+(-0.0030 0.0555 0.2595)
+(0.0000 0.0555 0.2595)
+(0.0030 0.0555 0.2595)
+(0.0060 0.0555 0.2595)
+(-0.0060 0.0585 0.2595)
+(-0.0030 0.0585 0.2595)
+(0.0000 0.0585 0.2595)
+(0.0030 0.0585 0.2595)
+(0.0060 0.0585 0.2595)
+(-0.0060 0.0615 0.2595)
+(-0.0030 0.0615 0.2595)
+(0.0000 0.0615 0.2595)
+(0.0030 0.0615 0.2595)
+(0.0060 0.0615 0.2595)
+(-0.0060 0.0645 0.2595)
+(-0.0030 0.0645 0.2595)
+(0.0000 0.0645 0.2595)
+(0.0030 0.0645 0.2595)
+(0.0060 0.0645 0.2595)
+(-0.0060 0.0675 0.2595)
+(-0.0030 0.0675 0.2595)
+(0.0000 0.0675 0.2595)
+(0.0030 0.0675 0.2595)
+(0.0060 0.0675 0.2595)
+(-0.0060 0.0705 0.2595)
+(-0.0030 0.0705 0.2595)
+(0.0000 0.0705 0.2595)
+(0.0030 0.0705 0.2595)
+(0.0060 0.0705 0.2595)
+(-0.0060 0.0735 0.2595)
+(-0.0030 0.0735 0.2595)
+(0.0000 0.0735 0.2595)
+(0.0030 0.0735 0.2595)
+(0.0060 0.0735 0.2595)
+(-0.0060 -0.0735 0.2625)
+(-0.0030 -0.0735 0.2625)
+(0.0000 -0.0735 0.2625)
+(0.0030 -0.0735 0.2625)
+(0.0060 -0.0735 0.2625)
+(-0.0060 -0.0705 0.2625)
+(-0.0030 -0.0705 0.2625)
+(0.0000 -0.0705 0.2625)
+(0.0030 -0.0705 0.2625)
+(0.0060 -0.0705 0.2625)
+(-0.0060 -0.0675 0.2625)
+(-0.0030 -0.0675 0.2625)
+(0.0000 -0.0675 0.2625)
+(0.0030 -0.0675 0.2625)
+(0.0060 -0.0675 0.2625)
+(-0.0060 -0.0645 0.2625)
+(-0.0030 -0.0645 0.2625)
+(0.0000 -0.0645 0.2625)
+(0.0030 -0.0645 0.2625)
+(0.0060 -0.0645 0.2625)
+(-0.0060 -0.0615 0.2625)
+(-0.0030 -0.0615 0.2625)
+(0.0000 -0.0615 0.2625)
+(0.0030 -0.0615 0.2625)
+(0.0060 -0.0615 0.2625)
+(-0.0060 -0.0585 0.2625)
+(-0.0030 -0.0585 0.2625)
+(0.0000 -0.0585 0.2625)
+(0.0030 -0.0585 0.2625)
+(0.0060 -0.0585 0.2625)
+(-0.0060 -0.0555 0.2625)
+(-0.0030 -0.0555 0.2625)
+(0.0000 -0.0555 0.2625)
+(0.0030 -0.0555 0.2625)
+(0.0060 -0.0555 0.2625)
+(-0.0060 -0.0525 0.2625)
+(-0.0030 -0.0525 0.2625)
+(0.0000 -0.0525 0.2625)
+(0.0030 -0.0525 0.2625)
+(0.0060 -0.0525 0.2625)
+(-0.0060 -0.0495 0.2625)
+(-0.0030 -0.0495 0.2625)
+(0.0000 -0.0495 0.2625)
+(0.0030 -0.0495 0.2625)
+(0.0060 -0.0495 0.2625)
+(-0.0060 -0.0465 0.2625)
+(-0.0030 -0.0465 0.2625)
+(0.0000 -0.0465 0.2625)
+(0.0030 -0.0465 0.2625)
+(0.0060 -0.0465 0.2625)
+(-0.0060 -0.0435 0.2625)
+(-0.0030 -0.0435 0.2625)
+(0.0000 -0.0435 0.2625)
+(0.0030 -0.0435 0.2625)
+(0.0060 -0.0435 0.2625)
+(-0.0060 -0.0405 0.2625)
+(-0.0030 -0.0405 0.2625)
+(0.0000 -0.0405 0.2625)
+(0.0030 -0.0405 0.2625)
+(0.0060 -0.0405 0.2625)
+(-0.0060 -0.0375 0.2625)
+(-0.0030 -0.0375 0.2625)
+(0.0000 -0.0375 0.2625)
+(0.0030 -0.0375 0.2625)
+(0.0060 -0.0375 0.2625)
+(-0.0060 -0.0345 0.2625)
+(-0.0030 -0.0345 0.2625)
+(0.0000 -0.0345 0.2625)
+(0.0030 -0.0345 0.2625)
+(0.0060 -0.0345 0.2625)
+(-0.0060 -0.0315 0.2625)
+(-0.0030 -0.0315 0.2625)
+(0.0000 -0.0315 0.2625)
+(0.0030 -0.0315 0.2625)
+(0.0060 -0.0315 0.2625)
+(-0.0060 -0.0285 0.2625)
+(-0.0030 -0.0285 0.2625)
+(0.0000 -0.0285 0.2625)
+(0.0030 -0.0285 0.2625)
+(0.0060 -0.0285 0.2625)
+(-0.0060 -0.0255 0.2625)
+(-0.0030 -0.0255 0.2625)
+(0.0000 -0.0255 0.2625)
+(0.0030 -0.0255 0.2625)
+(0.0060 -0.0255 0.2625)
+(-0.0060 -0.0225 0.2625)
+(-0.0030 -0.0225 0.2625)
+(0.0000 -0.0225 0.2625)
+(0.0030 -0.0225 0.2625)
+(0.0060 -0.0225 0.2625)
+(-0.0060 -0.0195 0.2625)
+(-0.0030 -0.0195 0.2625)
+(0.0000 -0.0195 0.2625)
+(0.0030 -0.0195 0.2625)
+(0.0060 -0.0195 0.2625)
+(-0.0060 -0.0165 0.2625)
+(-0.0030 -0.0165 0.2625)
+(0.0000 -0.0165 0.2625)
+(0.0030 -0.0165 0.2625)
+(0.0060 -0.0165 0.2625)
+(-0.0060 -0.0135 0.2625)
+(-0.0030 -0.0135 0.2625)
+(0.0000 -0.0135 0.2625)
+(0.0030 -0.0135 0.2625)
+(0.0060 -0.0135 0.2625)
+(-0.0060 -0.0105 0.2625)
+(-0.0030 -0.0105 0.2625)
+(0.0000 -0.0105 0.2625)
+(0.0030 -0.0105 0.2625)
+(0.0060 -0.0105 0.2625)
+(-0.0060 -0.0075 0.2625)
+(-0.0030 -0.0075 0.2625)
+(0.0000 -0.0075 0.2625)
+(0.0030 -0.0075 0.2625)
+(0.0060 -0.0075 0.2625)
+(-0.0060 -0.0045 0.2625)
+(-0.0030 -0.0045 0.2625)
+(0.0000 -0.0045 0.2625)
+(0.0030 -0.0045 0.2625)
+(0.0060 -0.0045 0.2625)
+(-0.0060 -0.0015 0.2625)
+(-0.0030 -0.0015 0.2625)
+(0.0000 -0.0015 0.2625)
+(0.0030 -0.0015 0.2625)
+(0.0060 -0.0015 0.2625)
+(-0.0060 0.0015 0.2625)
+(-0.0030 0.0015 0.2625)
+(0.0000 0.0015 0.2625)
+(0.0030 0.0015 0.2625)
+(0.0060 0.0015 0.2625)
+(-0.0060 0.0045 0.2625)
+(-0.0030 0.0045 0.2625)
+(0.0000 0.0045 0.2625)
+(0.0030 0.0045 0.2625)
+(0.0060 0.0045 0.2625)
+(-0.0060 0.0075 0.2625)
+(-0.0030 0.0075 0.2625)
+(0.0000 0.0075 0.2625)
+(0.0030 0.0075 0.2625)
+(0.0060 0.0075 0.2625)
+(-0.0060 0.0105 0.2625)
+(-0.0030 0.0105 0.2625)
+(0.0000 0.0105 0.2625)
+(0.0030 0.0105 0.2625)
+(0.0060 0.0105 0.2625)
+(-0.0060 0.0135 0.2625)
+(-0.0030 0.0135 0.2625)
+(0.0000 0.0135 0.2625)
+(0.0030 0.0135 0.2625)
+(0.0060 0.0135 0.2625)
+(-0.0060 0.0165 0.2625)
+(-0.0030 0.0165 0.2625)
+(0.0000 0.0165 0.2625)
+(0.0030 0.0165 0.2625)
+(0.0060 0.0165 0.2625)
+(-0.0060 0.0195 0.2625)
+(-0.0030 0.0195 0.2625)
+(0.0000 0.0195 0.2625)
+(0.0030 0.0195 0.2625)
+(0.0060 0.0195 0.2625)
+(-0.0060 0.0225 0.2625)
+(-0.0030 0.0225 0.2625)
+(0.0000 0.0225 0.2625)
+(0.0030 0.0225 0.2625)
+(0.0060 0.0225 0.2625)
+(-0.0060 0.0255 0.2625)
+(-0.0030 0.0255 0.2625)
+(0.0000 0.0255 0.2625)
+(0.0030 0.0255 0.2625)
+(0.0060 0.0255 0.2625)
+(-0.0060 0.0285 0.2625)
+(-0.0030 0.0285 0.2625)
+(0.0000 0.0285 0.2625)
+(0.0030 0.0285 0.2625)
+(0.0060 0.0285 0.2625)
+(-0.0060 0.0315 0.2625)
+(-0.0030 0.0315 0.2625)
+(0.0000 0.0315 0.2625)
+(0.0030 0.0315 0.2625)
+(0.0060 0.0315 0.2625)
+(-0.0060 0.0345 0.2625)
+(-0.0030 0.0345 0.2625)
+(0.0000 0.0345 0.2625)
+(0.0030 0.0345 0.2625)
+(0.0060 0.0345 0.2625)
+(-0.0060 0.0375 0.2625)
+(-0.0030 0.0375 0.2625)
+(0.0000 0.0375 0.2625)
+(0.0030 0.0375 0.2625)
+(0.0060 0.0375 0.2625)
+(-0.0060 0.0405 0.2625)
+(-0.0030 0.0405 0.2625)
+(0.0000 0.0405 0.2625)
+(0.0030 0.0405 0.2625)
+(0.0060 0.0405 0.2625)
+(-0.0060 0.0435 0.2625)
+(-0.0030 0.0435 0.2625)
+(0.0000 0.0435 0.2625)
+(0.0030 0.0435 0.2625)
+(0.0060 0.0435 0.2625)
+(-0.0060 0.0465 0.2625)
+(-0.0030 0.0465 0.2625)
+(0.0000 0.0465 0.2625)
+(0.0030 0.0465 0.2625)
+(0.0060 0.0465 0.2625)
+(-0.0060 0.0495 0.2625)
+(-0.0030 0.0495 0.2625)
+(0.0000 0.0495 0.2625)
+(0.0030 0.0495 0.2625)
+(0.0060 0.0495 0.2625)
+(-0.0060 0.0525 0.2625)
+(-0.0030 0.0525 0.2625)
+(0.0000 0.0525 0.2625)
+(0.0030 0.0525 0.2625)
+(0.0060 0.0525 0.2625)
+(-0.0060 0.0555 0.2625)
+(-0.0030 0.0555 0.2625)
+(0.0000 0.0555 0.2625)
+(0.0030 0.0555 0.2625)
+(0.0060 0.0555 0.2625)
+(-0.0060 0.0585 0.2625)
+(-0.0030 0.0585 0.2625)
+(0.0000 0.0585 0.2625)
+(0.0030 0.0585 0.2625)
+(0.0060 0.0585 0.2625)
+(-0.0060 0.0615 0.2625)
+(-0.0030 0.0615 0.2625)
+(0.0000 0.0615 0.2625)
+(0.0030 0.0615 0.2625)
+(0.0060 0.0615 0.2625)
+(-0.0060 0.0645 0.2625)
+(-0.0030 0.0645 0.2625)
+(0.0000 0.0645 0.2625)
+(0.0030 0.0645 0.2625)
+(0.0060 0.0645 0.2625)
+(-0.0060 0.0675 0.2625)
+(-0.0030 0.0675 0.2625)
+(0.0000 0.0675 0.2625)
+(0.0030 0.0675 0.2625)
+(0.0060 0.0675 0.2625)
+(-0.0060 0.0705 0.2625)
+(-0.0030 0.0705 0.2625)
+(0.0000 0.0705 0.2625)
+(0.0030 0.0705 0.2625)
+(0.0060 0.0705 0.2625)
+(-0.0060 0.0735 0.2625)
+(-0.0030 0.0735 0.2625)
+(0.0000 0.0735 0.2625)
+(0.0030 0.0735 0.2625)
+(0.0060 0.0735 0.2625)
+(-0.0060 -0.0735 0.2655)
+(-0.0030 -0.0735 0.2655)
+(0.0000 -0.0735 0.2655)
+(0.0030 -0.0735 0.2655)
+(0.0060 -0.0735 0.2655)
+(-0.0060 -0.0705 0.2655)
+(-0.0030 -0.0705 0.2655)
+(0.0000 -0.0705 0.2655)
+(0.0030 -0.0705 0.2655)
+(0.0060 -0.0705 0.2655)
+(-0.0060 -0.0675 0.2655)
+(-0.0030 -0.0675 0.2655)
+(0.0000 -0.0675 0.2655)
+(0.0030 -0.0675 0.2655)
+(0.0060 -0.0675 0.2655)
+(-0.0060 -0.0645 0.2655)
+(-0.0030 -0.0645 0.2655)
+(0.0000 -0.0645 0.2655)
+(0.0030 -0.0645 0.2655)
+(0.0060 -0.0645 0.2655)
+(-0.0060 -0.0615 0.2655)
+(-0.0030 -0.0615 0.2655)
+(0.0000 -0.0615 0.2655)
+(0.0030 -0.0615 0.2655)
+(0.0060 -0.0615 0.2655)
+(-0.0060 -0.0585 0.2655)
+(-0.0030 -0.0585 0.2655)
+(0.0000 -0.0585 0.2655)
+(0.0030 -0.0585 0.2655)
+(0.0060 -0.0585 0.2655)
+(-0.0060 -0.0555 0.2655)
+(-0.0030 -0.0555 0.2655)
+(0.0000 -0.0555 0.2655)
+(0.0030 -0.0555 0.2655)
+(0.0060 -0.0555 0.2655)
+(-0.0060 -0.0525 0.2655)
+(-0.0030 -0.0525 0.2655)
+(0.0000 -0.0525 0.2655)
+(0.0030 -0.0525 0.2655)
+(0.0060 -0.0525 0.2655)
+(-0.0060 -0.0495 0.2655)
+(-0.0030 -0.0495 0.2655)
+(0.0000 -0.0495 0.2655)
+(0.0030 -0.0495 0.2655)
+(0.0060 -0.0495 0.2655)
+(-0.0060 -0.0465 0.2655)
+(-0.0030 -0.0465 0.2655)
+(0.0000 -0.0465 0.2655)
+(0.0030 -0.0465 0.2655)
+(0.0060 -0.0465 0.2655)
+(-0.0060 -0.0435 0.2655)
+(-0.0030 -0.0435 0.2655)
+(0.0000 -0.0435 0.2655)
+(0.0030 -0.0435 0.2655)
+(0.0060 -0.0435 0.2655)
+(-0.0060 -0.0405 0.2655)
+(-0.0030 -0.0405 0.2655)
+(0.0000 -0.0405 0.2655)
+(0.0030 -0.0405 0.2655)
+(0.0060 -0.0405 0.2655)
+(-0.0060 -0.0375 0.2655)
+(-0.0030 -0.0375 0.2655)
+(0.0000 -0.0375 0.2655)
+(0.0030 -0.0375 0.2655)
+(0.0060 -0.0375 0.2655)
+(-0.0060 -0.0345 0.2655)
+(-0.0030 -0.0345 0.2655)
+(0.0000 -0.0345 0.2655)
+(0.0030 -0.0345 0.2655)
+(0.0060 -0.0345 0.2655)
+(-0.0060 -0.0315 0.2655)
+(-0.0030 -0.0315 0.2655)
+(0.0000 -0.0315 0.2655)
+(0.0030 -0.0315 0.2655)
+(0.0060 -0.0315 0.2655)
+(-0.0060 -0.0285 0.2655)
+(-0.0030 -0.0285 0.2655)
+(0.0000 -0.0285 0.2655)
+(0.0030 -0.0285 0.2655)
+(0.0060 -0.0285 0.2655)
+(-0.0060 -0.0255 0.2655)
+(-0.0030 -0.0255 0.2655)
+(0.0000 -0.0255 0.2655)
+(0.0030 -0.0255 0.2655)
+(0.0060 -0.0255 0.2655)
+(-0.0060 -0.0225 0.2655)
+(-0.0030 -0.0225 0.2655)
+(0.0000 -0.0225 0.2655)
+(0.0030 -0.0225 0.2655)
+(0.0060 -0.0225 0.2655)
+(-0.0060 -0.0195 0.2655)
+(-0.0030 -0.0195 0.2655)
+(0.0000 -0.0195 0.2655)
+(0.0030 -0.0195 0.2655)
+(0.0060 -0.0195 0.2655)
+(-0.0060 -0.0165 0.2655)
+(-0.0030 -0.0165 0.2655)
+(0.0000 -0.0165 0.2655)
+(0.0030 -0.0165 0.2655)
+(0.0060 -0.0165 0.2655)
+(-0.0060 -0.0135 0.2655)
+(-0.0030 -0.0135 0.2655)
+(0.0000 -0.0135 0.2655)
+(0.0030 -0.0135 0.2655)
+(0.0060 -0.0135 0.2655)
+(-0.0060 -0.0105 0.2655)
+(-0.0030 -0.0105 0.2655)
+(0.0000 -0.0105 0.2655)
+(0.0030 -0.0105 0.2655)
+(0.0060 -0.0105 0.2655)
+(-0.0060 -0.0075 0.2655)
+(-0.0030 -0.0075 0.2655)
+(0.0000 -0.0075 0.2655)
+(0.0030 -0.0075 0.2655)
+(0.0060 -0.0075 0.2655)
+(-0.0060 -0.0045 0.2655)
+(-0.0030 -0.0045 0.2655)
+(0.0000 -0.0045 0.2655)
+(0.0030 -0.0045 0.2655)
+(0.0060 -0.0045 0.2655)
+(-0.0060 -0.0015 0.2655)
+(-0.0030 -0.0015 0.2655)
+(0.0000 -0.0015 0.2655)
+(0.0030 -0.0015 0.2655)
+(0.0060 -0.0015 0.2655)
+(-0.0060 0.0015 0.2655)
+(-0.0030 0.0015 0.2655)
+(0.0000 0.0015 0.2655)
+(0.0030 0.0015 0.2655)
+(0.0060 0.0015 0.2655)
+(-0.0060 0.0045 0.2655)
+(-0.0030 0.0045 0.2655)
+(0.0000 0.0045 0.2655)
+(0.0030 0.0045 0.2655)
+(0.0060 0.0045 0.2655)
+(-0.0060 0.0075 0.2655)
+(-0.0030 0.0075 0.2655)
+(0.0000 0.0075 0.2655)
+(0.0030 0.0075 0.2655)
+(0.0060 0.0075 0.2655)
+(-0.0060 0.0105 0.2655)
+(-0.0030 0.0105 0.2655)
+(0.0000 0.0105 0.2655)
+(0.0030 0.0105 0.2655)
+(0.0060 0.0105 0.2655)
+(-0.0060 0.0135 0.2655)
+(-0.0030 0.0135 0.2655)
+(0.0000 0.0135 0.2655)
+(0.0030 0.0135 0.2655)
+(0.0060 0.0135 0.2655)
+(-0.0060 0.0165 0.2655)
+(-0.0030 0.0165 0.2655)
+(0.0000 0.0165 0.2655)
+(0.0030 0.0165 0.2655)
+(0.0060 0.0165 0.2655)
+(-0.0060 0.0195 0.2655)
+(-0.0030 0.0195 0.2655)
+(0.0000 0.0195 0.2655)
+(0.0030 0.0195 0.2655)
+(0.0060 0.0195 0.2655)
+(-0.0060 0.0225 0.2655)
+(-0.0030 0.0225 0.2655)
+(0.0000 0.0225 0.2655)
+(0.0030 0.0225 0.2655)
+(0.0060 0.0225 0.2655)
+(-0.0060 0.0255 0.2655)
+(-0.0030 0.0255 0.2655)
+(0.0000 0.0255 0.2655)
+(0.0030 0.0255 0.2655)
+(0.0060 0.0255 0.2655)
+(-0.0060 0.0285 0.2655)
+(-0.0030 0.0285 0.2655)
+(0.0000 0.0285 0.2655)
+(0.0030 0.0285 0.2655)
+(0.0060 0.0285 0.2655)
+(-0.0060 0.0315 0.2655)
+(-0.0030 0.0315 0.2655)
+(0.0000 0.0315 0.2655)
+(0.0030 0.0315 0.2655)
+(0.0060 0.0315 0.2655)
+(-0.0060 0.0345 0.2655)
+(-0.0030 0.0345 0.2655)
+(0.0000 0.0345 0.2655)
+(0.0030 0.0345 0.2655)
+(0.0060 0.0345 0.2655)
+(-0.0060 0.0375 0.2655)
+(-0.0030 0.0375 0.2655)
+(0.0000 0.0375 0.2655)
+(0.0030 0.0375 0.2655)
+(0.0060 0.0375 0.2655)
+(-0.0060 0.0405 0.2655)
+(-0.0030 0.0405 0.2655)
+(0.0000 0.0405 0.2655)
+(0.0030 0.0405 0.2655)
+(0.0060 0.0405 0.2655)
+(-0.0060 0.0435 0.2655)
+(-0.0030 0.0435 0.2655)
+(0.0000 0.0435 0.2655)
+(0.0030 0.0435 0.2655)
+(0.0060 0.0435 0.2655)
+(-0.0060 0.0465 0.2655)
+(-0.0030 0.0465 0.2655)
+(0.0000 0.0465 0.2655)
+(0.0030 0.0465 0.2655)
+(0.0060 0.0465 0.2655)
+(-0.0060 0.0495 0.2655)
+(-0.0030 0.0495 0.2655)
+(0.0000 0.0495 0.2655)
+(0.0030 0.0495 0.2655)
+(0.0060 0.0495 0.2655)
+(-0.0060 0.0525 0.2655)
+(-0.0030 0.0525 0.2655)
+(0.0000 0.0525 0.2655)
+(0.0030 0.0525 0.2655)
+(0.0060 0.0525 0.2655)
+(-0.0060 0.0555 0.2655)
+(-0.0030 0.0555 0.2655)
+(0.0000 0.0555 0.2655)
+(0.0030 0.0555 0.2655)
+(0.0060 0.0555 0.2655)
+(-0.0060 0.0585 0.2655)
+(-0.0030 0.0585 0.2655)
+(0.0000 0.0585 0.2655)
+(0.0030 0.0585 0.2655)
+(0.0060 0.0585 0.2655)
+(-0.0060 0.0615 0.2655)
+(-0.0030 0.0615 0.2655)
+(0.0000 0.0615 0.2655)
+(0.0030 0.0615 0.2655)
+(0.0060 0.0615 0.2655)
+(-0.0060 0.0645 0.2655)
+(-0.0030 0.0645 0.2655)
+(0.0000 0.0645 0.2655)
+(0.0030 0.0645 0.2655)
+(0.0060 0.0645 0.2655)
+(-0.0060 0.0675 0.2655)
+(-0.0030 0.0675 0.2655)
+(0.0000 0.0675 0.2655)
+(0.0030 0.0675 0.2655)
+(0.0060 0.0675 0.2655)
+(-0.0060 0.0705 0.2655)
+(-0.0030 0.0705 0.2655)
+(0.0000 0.0705 0.2655)
+(0.0030 0.0705 0.2655)
+(0.0060 0.0705 0.2655)
+(-0.0060 0.0735 0.2655)
+(-0.0030 0.0735 0.2655)
+(0.0000 0.0735 0.2655)
+(0.0030 0.0735 0.2655)
+(0.0060 0.0735 0.2655)
+(-0.0060 -0.0735 0.2685)
+(-0.0030 -0.0735 0.2685)
+(0.0000 -0.0735 0.2685)
+(0.0030 -0.0735 0.2685)
+(0.0060 -0.0735 0.2685)
+(-0.0060 -0.0705 0.2685)
+(-0.0030 -0.0705 0.2685)
+(0.0000 -0.0705 0.2685)
+(0.0030 -0.0705 0.2685)
+(0.0060 -0.0705 0.2685)
+(-0.0060 -0.0675 0.2685)
+(-0.0030 -0.0675 0.2685)
+(0.0000 -0.0675 0.2685)
+(0.0030 -0.0675 0.2685)
+(0.0060 -0.0675 0.2685)
+(-0.0060 -0.0645 0.2685)
+(-0.0030 -0.0645 0.2685)
+(0.0000 -0.0645 0.2685)
+(0.0030 -0.0645 0.2685)
+(0.0060 -0.0645 0.2685)
+(-0.0060 -0.0615 0.2685)
+(-0.0030 -0.0615 0.2685)
+(0.0000 -0.0615 0.2685)
+(0.0030 -0.0615 0.2685)
+(0.0060 -0.0615 0.2685)
+(-0.0060 -0.0585 0.2685)
+(-0.0030 -0.0585 0.2685)
+(0.0000 -0.0585 0.2685)
+(0.0030 -0.0585 0.2685)
+(0.0060 -0.0585 0.2685)
+(-0.0060 -0.0555 0.2685)
+(-0.0030 -0.0555 0.2685)
+(0.0000 -0.0555 0.2685)
+(0.0030 -0.0555 0.2685)
+(0.0060 -0.0555 0.2685)
+(-0.0060 -0.0525 0.2685)
+(-0.0030 -0.0525 0.2685)
+(0.0000 -0.0525 0.2685)
+(0.0030 -0.0525 0.2685)
+(0.0060 -0.0525 0.2685)
+(-0.0060 -0.0495 0.2685)
+(-0.0030 -0.0495 0.2685)
+(0.0000 -0.0495 0.2685)
+(0.0030 -0.0495 0.2685)
+(0.0060 -0.0495 0.2685)
+(-0.0060 -0.0465 0.2685)
+(-0.0030 -0.0465 0.2685)
+(0.0000 -0.0465 0.2685)
+(0.0030 -0.0465 0.2685)
+(0.0060 -0.0465 0.2685)
+(-0.0060 -0.0435 0.2685)
+(-0.0030 -0.0435 0.2685)
+(0.0000 -0.0435 0.2685)
+(0.0030 -0.0435 0.2685)
+(0.0060 -0.0435 0.2685)
+(-0.0060 -0.0405 0.2685)
+(-0.0030 -0.0405 0.2685)
+(0.0000 -0.0405 0.2685)
+(0.0030 -0.0405 0.2685)
+(0.0060 -0.0405 0.2685)
+(-0.0060 -0.0375 0.2685)
+(-0.0030 -0.0375 0.2685)
+(0.0000 -0.0375 0.2685)
+(0.0030 -0.0375 0.2685)
+(0.0060 -0.0375 0.2685)
+(-0.0060 -0.0345 0.2685)
+(-0.0030 -0.0345 0.2685)
+(0.0000 -0.0345 0.2685)
+(0.0030 -0.0345 0.2685)
+(0.0060 -0.0345 0.2685)
+(-0.0060 -0.0315 0.2685)
+(-0.0030 -0.0315 0.2685)
+(0.0000 -0.0315 0.2685)
+(0.0030 -0.0315 0.2685)
+(0.0060 -0.0315 0.2685)
+(-0.0060 -0.0285 0.2685)
+(-0.0030 -0.0285 0.2685)
+(0.0000 -0.0285 0.2685)
+(0.0030 -0.0285 0.2685)
+(0.0060 -0.0285 0.2685)
+(-0.0060 -0.0255 0.2685)
+(-0.0030 -0.0255 0.2685)
+(0.0000 -0.0255 0.2685)
+(0.0030 -0.0255 0.2685)
+(0.0060 -0.0255 0.2685)
+(-0.0060 -0.0225 0.2685)
+(-0.0030 -0.0225 0.2685)
+(0.0000 -0.0225 0.2685)
+(0.0030 -0.0225 0.2685)
+(0.0060 -0.0225 0.2685)
+(-0.0060 -0.0195 0.2685)
+(-0.0030 -0.0195 0.2685)
+(0.0000 -0.0195 0.2685)
+(0.0030 -0.0195 0.2685)
+(0.0060 -0.0195 0.2685)
+(-0.0060 -0.0165 0.2685)
+(-0.0030 -0.0165 0.2685)
+(0.0000 -0.0165 0.2685)
+(0.0030 -0.0165 0.2685)
+(0.0060 -0.0165 0.2685)
+(-0.0060 -0.0135 0.2685)
+(-0.0030 -0.0135 0.2685)
+(0.0000 -0.0135 0.2685)
+(0.0030 -0.0135 0.2685)
+(0.0060 -0.0135 0.2685)
+(-0.0060 -0.0105 0.2685)
+(-0.0030 -0.0105 0.2685)
+(0.0000 -0.0105 0.2685)
+(0.0030 -0.0105 0.2685)
+(0.0060 -0.0105 0.2685)
+(-0.0060 -0.0075 0.2685)
+(-0.0030 -0.0075 0.2685)
+(0.0000 -0.0075 0.2685)
+(0.0030 -0.0075 0.2685)
+(0.0060 -0.0075 0.2685)
+(-0.0060 -0.0045 0.2685)
+(-0.0030 -0.0045 0.2685)
+(0.0000 -0.0045 0.2685)
+(0.0030 -0.0045 0.2685)
+(0.0060 -0.0045 0.2685)
+(-0.0060 -0.0015 0.2685)
+(-0.0030 -0.0015 0.2685)
+(0.0000 -0.0015 0.2685)
+(0.0030 -0.0015 0.2685)
+(0.0060 -0.0015 0.2685)
+(-0.0060 0.0015 0.2685)
+(-0.0030 0.0015 0.2685)
+(0.0000 0.0015 0.2685)
+(0.0030 0.0015 0.2685)
+(0.0060 0.0015 0.2685)
+(-0.0060 0.0045 0.2685)
+(-0.0030 0.0045 0.2685)
+(0.0000 0.0045 0.2685)
+(0.0030 0.0045 0.2685)
+(0.0060 0.0045 0.2685)
+(-0.0060 0.0075 0.2685)
+(-0.0030 0.0075 0.2685)
+(0.0000 0.0075 0.2685)
+(0.0030 0.0075 0.2685)
+(0.0060 0.0075 0.2685)
+(-0.0060 0.0105 0.2685)
+(-0.0030 0.0105 0.2685)
+(0.0000 0.0105 0.2685)
+(0.0030 0.0105 0.2685)
+(0.0060 0.0105 0.2685)
+(-0.0060 0.0135 0.2685)
+(-0.0030 0.0135 0.2685)
+(0.0000 0.0135 0.2685)
+(0.0030 0.0135 0.2685)
+(0.0060 0.0135 0.2685)
+(-0.0060 0.0165 0.2685)
+(-0.0030 0.0165 0.2685)
+(0.0000 0.0165 0.2685)
+(0.0030 0.0165 0.2685)
+(0.0060 0.0165 0.2685)
+(-0.0060 0.0195 0.2685)
+(-0.0030 0.0195 0.2685)
+(0.0000 0.0195 0.2685)
+(0.0030 0.0195 0.2685)
+(0.0060 0.0195 0.2685)
+(-0.0060 0.0225 0.2685)
+(-0.0030 0.0225 0.2685)
+(0.0000 0.0225 0.2685)
+(0.0030 0.0225 0.2685)
+(0.0060 0.0225 0.2685)
+(-0.0060 0.0255 0.2685)
+(-0.0030 0.0255 0.2685)
+(0.0000 0.0255 0.2685)
+(0.0030 0.0255 0.2685)
+(0.0060 0.0255 0.2685)
+(-0.0060 0.0285 0.2685)
+(-0.0030 0.0285 0.2685)
+(0.0000 0.0285 0.2685)
+(0.0030 0.0285 0.2685)
+(0.0060 0.0285 0.2685)
+(-0.0060 0.0315 0.2685)
+(-0.0030 0.0315 0.2685)
+(0.0000 0.0315 0.2685)
+(0.0030 0.0315 0.2685)
+(0.0060 0.0315 0.2685)
+(-0.0060 0.0345 0.2685)
+(-0.0030 0.0345 0.2685)
+(0.0000 0.0345 0.2685)
+(0.0030 0.0345 0.2685)
+(0.0060 0.0345 0.2685)
+(-0.0060 0.0375 0.2685)
+(-0.0030 0.0375 0.2685)
+(0.0000 0.0375 0.2685)
+(0.0030 0.0375 0.2685)
+(0.0060 0.0375 0.2685)
+(-0.0060 0.0405 0.2685)
+(-0.0030 0.0405 0.2685)
+(0.0000 0.0405 0.2685)
+(0.0030 0.0405 0.2685)
+(0.0060 0.0405 0.2685)
+(-0.0060 0.0435 0.2685)
+(-0.0030 0.0435 0.2685)
+(0.0000 0.0435 0.2685)
+(0.0030 0.0435 0.2685)
+(0.0060 0.0435 0.2685)
+(-0.0060 0.0465 0.2685)
+(-0.0030 0.0465 0.2685)
+(0.0000 0.0465 0.2685)
+(0.0030 0.0465 0.2685)
+(0.0060 0.0465 0.2685)
+(-0.0060 0.0495 0.2685)
+(-0.0030 0.0495 0.2685)
+(0.0000 0.0495 0.2685)
+(0.0030 0.0495 0.2685)
+(0.0060 0.0495 0.2685)
+(-0.0060 0.0525 0.2685)
+(-0.0030 0.0525 0.2685)
+(0.0000 0.0525 0.2685)
+(0.0030 0.0525 0.2685)
+(0.0060 0.0525 0.2685)
+(-0.0060 0.0555 0.2685)
+(-0.0030 0.0555 0.2685)
+(0.0000 0.0555 0.2685)
+(0.0030 0.0555 0.2685)
+(0.0060 0.0555 0.2685)
+(-0.0060 0.0585 0.2685)
+(-0.0030 0.0585 0.2685)
+(0.0000 0.0585 0.2685)
+(0.0030 0.0585 0.2685)
+(0.0060 0.0585 0.2685)
+(-0.0060 0.0615 0.2685)
+(-0.0030 0.0615 0.2685)
+(0.0000 0.0615 0.2685)
+(0.0030 0.0615 0.2685)
+(0.0060 0.0615 0.2685)
+(-0.0060 0.0645 0.2685)
+(-0.0030 0.0645 0.2685)
+(0.0000 0.0645 0.2685)
+(0.0030 0.0645 0.2685)
+(0.0060 0.0645 0.2685)
+(-0.0060 0.0675 0.2685)
+(-0.0030 0.0675 0.2685)
+(0.0000 0.0675 0.2685)
+(0.0030 0.0675 0.2685)
+(0.0060 0.0675 0.2685)
+(-0.0060 0.0705 0.2685)
+(-0.0030 0.0705 0.2685)
+(0.0000 0.0705 0.2685)
+(0.0030 0.0705 0.2685)
+(0.0060 0.0705 0.2685)
+(-0.0060 0.0735 0.2685)
+(-0.0030 0.0735 0.2685)
+(0.0000 0.0735 0.2685)
+(0.0030 0.0735 0.2685)
+(0.0060 0.0735 0.2685)
+(-0.0060 -0.0735 0.2715)
+(-0.0030 -0.0735 0.2715)
+(0.0000 -0.0735 0.2715)
+(0.0030 -0.0735 0.2715)
+(0.0060 -0.0735 0.2715)
+(-0.0060 -0.0705 0.2715)
+(-0.0030 -0.0705 0.2715)
+(0.0000 -0.0705 0.2715)
+(0.0030 -0.0705 0.2715)
+(0.0060 -0.0705 0.2715)
+(-0.0060 -0.0675 0.2715)
+(-0.0030 -0.0675 0.2715)
+(0.0000 -0.0675 0.2715)
+(0.0030 -0.0675 0.2715)
+(0.0060 -0.0675 0.2715)
+(-0.0060 -0.0645 0.2715)
+(-0.0030 -0.0645 0.2715)
+(0.0000 -0.0645 0.2715)
+(0.0030 -0.0645 0.2715)
+(0.0060 -0.0645 0.2715)
+(-0.0060 -0.0615 0.2715)
+(-0.0030 -0.0615 0.2715)
+(0.0000 -0.0615 0.2715)
+(0.0030 -0.0615 0.2715)
+(0.0060 -0.0615 0.2715)
+(-0.0060 -0.0585 0.2715)
+(-0.0030 -0.0585 0.2715)
+(0.0000 -0.0585 0.2715)
+(0.0030 -0.0585 0.2715)
+(0.0060 -0.0585 0.2715)
+(-0.0060 -0.0555 0.2715)
+(-0.0030 -0.0555 0.2715)
+(0.0000 -0.0555 0.2715)
+(0.0030 -0.0555 0.2715)
+(0.0060 -0.0555 0.2715)
+(-0.0060 -0.0525 0.2715)
+(-0.0030 -0.0525 0.2715)
+(0.0000 -0.0525 0.2715)
+(0.0030 -0.0525 0.2715)
+(0.0060 -0.0525 0.2715)
+(-0.0060 -0.0495 0.2715)
+(-0.0030 -0.0495 0.2715)
+(0.0000 -0.0495 0.2715)
+(0.0030 -0.0495 0.2715)
+(0.0060 -0.0495 0.2715)
+(-0.0060 -0.0465 0.2715)
+(-0.0030 -0.0465 0.2715)
+(0.0000 -0.0465 0.2715)
+(0.0030 -0.0465 0.2715)
+(0.0060 -0.0465 0.2715)
+(-0.0060 -0.0435 0.2715)
+(-0.0030 -0.0435 0.2715)
+(0.0000 -0.0435 0.2715)
+(0.0030 -0.0435 0.2715)
+(0.0060 -0.0435 0.2715)
+(-0.0060 -0.0405 0.2715)
+(-0.0030 -0.0405 0.2715)
+(0.0000 -0.0405 0.2715)
+(0.0030 -0.0405 0.2715)
+(0.0060 -0.0405 0.2715)
+(-0.0060 -0.0375 0.2715)
+(-0.0030 -0.0375 0.2715)
+(0.0000 -0.0375 0.2715)
+(0.0030 -0.0375 0.2715)
+(0.0060 -0.0375 0.2715)
+(-0.0060 -0.0345 0.2715)
+(-0.0030 -0.0345 0.2715)
+(0.0000 -0.0345 0.2715)
+(0.0030 -0.0345 0.2715)
+(0.0060 -0.0345 0.2715)
+(-0.0060 -0.0315 0.2715)
+(-0.0030 -0.0315 0.2715)
+(0.0000 -0.0315 0.2715)
+(0.0030 -0.0315 0.2715)
+(0.0060 -0.0315 0.2715)
+(-0.0060 -0.0285 0.2715)
+(-0.0030 -0.0285 0.2715)
+(0.0000 -0.0285 0.2715)
+(0.0030 -0.0285 0.2715)
+(0.0060 -0.0285 0.2715)
+(-0.0060 -0.0255 0.2715)
+(-0.0030 -0.0255 0.2715)
+(0.0000 -0.0255 0.2715)
+(0.0030 -0.0255 0.2715)
+(0.0060 -0.0255 0.2715)
+(-0.0060 -0.0225 0.2715)
+(-0.0030 -0.0225 0.2715)
+(0.0000 -0.0225 0.2715)
+(0.0030 -0.0225 0.2715)
+(0.0060 -0.0225 0.2715)
+(-0.0060 -0.0195 0.2715)
+(-0.0030 -0.0195 0.2715)
+(0.0000 -0.0195 0.2715)
+(0.0030 -0.0195 0.2715)
+(0.0060 -0.0195 0.2715)
+(-0.0060 -0.0165 0.2715)
+(-0.0030 -0.0165 0.2715)
+(0.0000 -0.0165 0.2715)
+(0.0030 -0.0165 0.2715)
+(0.0060 -0.0165 0.2715)
+(-0.0060 -0.0135 0.2715)
+(-0.0030 -0.0135 0.2715)
+(0.0000 -0.0135 0.2715)
+(0.0030 -0.0135 0.2715)
+(0.0060 -0.0135 0.2715)
+(-0.0060 -0.0105 0.2715)
+(-0.0030 -0.0105 0.2715)
+(0.0000 -0.0105 0.2715)
+(0.0030 -0.0105 0.2715)
+(0.0060 -0.0105 0.2715)
+(-0.0060 -0.0075 0.2715)
+(-0.0030 -0.0075 0.2715)
+(0.0000 -0.0075 0.2715)
+(0.0030 -0.0075 0.2715)
+(0.0060 -0.0075 0.2715)
+(-0.0060 -0.0045 0.2715)
+(-0.0030 -0.0045 0.2715)
+(0.0000 -0.0045 0.2715)
+(0.0030 -0.0045 0.2715)
+(0.0060 -0.0045 0.2715)
+(-0.0060 -0.0015 0.2715)
+(-0.0030 -0.0015 0.2715)
+(0.0000 -0.0015 0.2715)
+(0.0030 -0.0015 0.2715)
+(0.0060 -0.0015 0.2715)
+(-0.0060 0.0015 0.2715)
+(-0.0030 0.0015 0.2715)
+(0.0000 0.0015 0.2715)
+(0.0030 0.0015 0.2715)
+(0.0060 0.0015 0.2715)
+(-0.0060 0.0045 0.2715)
+(-0.0030 0.0045 0.2715)
+(0.0000 0.0045 0.2715)
+(0.0030 0.0045 0.2715)
+(0.0060 0.0045 0.2715)
+(-0.0060 0.0075 0.2715)
+(-0.0030 0.0075 0.2715)
+(0.0000 0.0075 0.2715)
+(0.0030 0.0075 0.2715)
+(0.0060 0.0075 0.2715)
+(-0.0060 0.0105 0.2715)
+(-0.0030 0.0105 0.2715)
+(0.0000 0.0105 0.2715)
+(0.0030 0.0105 0.2715)
+(0.0060 0.0105 0.2715)
+(-0.0060 0.0135 0.2715)
+(-0.0030 0.0135 0.2715)
+(0.0000 0.0135 0.2715)
+(0.0030 0.0135 0.2715)
+(0.0060 0.0135 0.2715)
+(-0.0060 0.0165 0.2715)
+(-0.0030 0.0165 0.2715)
+(0.0000 0.0165 0.2715)
+(0.0030 0.0165 0.2715)
+(0.0060 0.0165 0.2715)
+(-0.0060 0.0195 0.2715)
+(-0.0030 0.0195 0.2715)
+(0.0000 0.0195 0.2715)
+(0.0030 0.0195 0.2715)
+(0.0060 0.0195 0.2715)
+(-0.0060 0.0225 0.2715)
+(-0.0030 0.0225 0.2715)
+(0.0000 0.0225 0.2715)
+(0.0030 0.0225 0.2715)
+(0.0060 0.0225 0.2715)
+(-0.0060 0.0255 0.2715)
+(-0.0030 0.0255 0.2715)
+(0.0000 0.0255 0.2715)
+(0.0030 0.0255 0.2715)
+(0.0060 0.0255 0.2715)
+(-0.0060 0.0285 0.2715)
+(-0.0030 0.0285 0.2715)
+(0.0000 0.0285 0.2715)
+(0.0030 0.0285 0.2715)
+(0.0060 0.0285 0.2715)
+(-0.0060 0.0315 0.2715)
+(-0.0030 0.0315 0.2715)
+(0.0000 0.0315 0.2715)
+(0.0030 0.0315 0.2715)
+(0.0060 0.0315 0.2715)
+(-0.0060 0.0345 0.2715)
+(-0.0030 0.0345 0.2715)
+(0.0000 0.0345 0.2715)
+(0.0030 0.0345 0.2715)
+(0.0060 0.0345 0.2715)
+(-0.0060 0.0375 0.2715)
+(-0.0030 0.0375 0.2715)
+(0.0000 0.0375 0.2715)
+(0.0030 0.0375 0.2715)
+(0.0060 0.0375 0.2715)
+(-0.0060 0.0405 0.2715)
+(-0.0030 0.0405 0.2715)
+(0.0000 0.0405 0.2715)
+(0.0030 0.0405 0.2715)
+(0.0060 0.0405 0.2715)
+(-0.0060 0.0435 0.2715)
+(-0.0030 0.0435 0.2715)
+(0.0000 0.0435 0.2715)
+(0.0030 0.0435 0.2715)
+(0.0060 0.0435 0.2715)
+(-0.0060 0.0465 0.2715)
+(-0.0030 0.0465 0.2715)
+(0.0000 0.0465 0.2715)
+(0.0030 0.0465 0.2715)
+(0.0060 0.0465 0.2715)
+(-0.0060 0.0495 0.2715)
+(-0.0030 0.0495 0.2715)
+(0.0000 0.0495 0.2715)
+(0.0030 0.0495 0.2715)
+(0.0060 0.0495 0.2715)
+(-0.0060 0.0525 0.2715)
+(-0.0030 0.0525 0.2715)
+(0.0000 0.0525 0.2715)
+(0.0030 0.0525 0.2715)
+(0.0060 0.0525 0.2715)
+(-0.0060 0.0555 0.2715)
+(-0.0030 0.0555 0.2715)
+(0.0000 0.0555 0.2715)
+(0.0030 0.0555 0.2715)
+(0.0060 0.0555 0.2715)
+(-0.0060 0.0585 0.2715)
+(-0.0030 0.0585 0.2715)
+(0.0000 0.0585 0.2715)
+(0.0030 0.0585 0.2715)
+(0.0060 0.0585 0.2715)
+(-0.0060 0.0615 0.2715)
+(-0.0030 0.0615 0.2715)
+(0.0000 0.0615 0.2715)
+(0.0030 0.0615 0.2715)
+(0.0060 0.0615 0.2715)
+(-0.0060 0.0645 0.2715)
+(-0.0030 0.0645 0.2715)
+(0.0000 0.0645 0.2715)
+(0.0030 0.0645 0.2715)
+(0.0060 0.0645 0.2715)
+(-0.0060 0.0675 0.2715)
+(-0.0030 0.0675 0.2715)
+(0.0000 0.0675 0.2715)
+(0.0030 0.0675 0.2715)
+(0.0060 0.0675 0.2715)
+(-0.0060 0.0705 0.2715)
+(-0.0030 0.0705 0.2715)
+(0.0000 0.0705 0.2715)
+(0.0030 0.0705 0.2715)
+(0.0060 0.0705 0.2715)
+(-0.0060 0.0735 0.2715)
+(-0.0030 0.0735 0.2715)
+(0.0000 0.0735 0.2715)
+(0.0030 0.0735 0.2715)
+(0.0060 0.0735 0.2715)
+(-0.0060 -0.0735 0.2745)
+(-0.0030 -0.0735 0.2745)
+(0.0000 -0.0735 0.2745)
+(0.0030 -0.0735 0.2745)
+(0.0060 -0.0735 0.2745)
+(-0.0060 -0.0705 0.2745)
+(-0.0030 -0.0705 0.2745)
+(0.0000 -0.0705 0.2745)
+(0.0030 -0.0705 0.2745)
+(0.0060 -0.0705 0.2745)
+(-0.0060 -0.0675 0.2745)
+(-0.0030 -0.0675 0.2745)
+(0.0000 -0.0675 0.2745)
+(0.0030 -0.0675 0.2745)
+(0.0060 -0.0675 0.2745)
+(-0.0060 -0.0645 0.2745)
+(-0.0030 -0.0645 0.2745)
+(0.0000 -0.0645 0.2745)
+(0.0030 -0.0645 0.2745)
+(0.0060 -0.0645 0.2745)
+(-0.0060 -0.0615 0.2745)
+(-0.0030 -0.0615 0.2745)
+(0.0000 -0.0615 0.2745)
+(0.0030 -0.0615 0.2745)
+(0.0060 -0.0615 0.2745)
+(-0.0060 -0.0585 0.2745)
+(-0.0030 -0.0585 0.2745)
+(0.0000 -0.0585 0.2745)
+(0.0030 -0.0585 0.2745)
+(0.0060 -0.0585 0.2745)
+(-0.0060 -0.0555 0.2745)
+(-0.0030 -0.0555 0.2745)
+(0.0000 -0.0555 0.2745)
+(0.0030 -0.0555 0.2745)
+(0.0060 -0.0555 0.2745)
+(-0.0060 -0.0525 0.2745)
+(-0.0030 -0.0525 0.2745)
+(0.0000 -0.0525 0.2745)
+(0.0030 -0.0525 0.2745)
+(0.0060 -0.0525 0.2745)
+(-0.0060 -0.0495 0.2745)
+(-0.0030 -0.0495 0.2745)
+(0.0000 -0.0495 0.2745)
+(0.0030 -0.0495 0.2745)
+(0.0060 -0.0495 0.2745)
+(-0.0060 -0.0465 0.2745)
+(-0.0030 -0.0465 0.2745)
+(0.0000 -0.0465 0.2745)
+(0.0030 -0.0465 0.2745)
+(0.0060 -0.0465 0.2745)
+(-0.0060 -0.0435 0.2745)
+(-0.0030 -0.0435 0.2745)
+(0.0000 -0.0435 0.2745)
+(0.0030 -0.0435 0.2745)
+(0.0060 -0.0435 0.2745)
+(-0.0060 -0.0405 0.2745)
+(-0.0030 -0.0405 0.2745)
+(0.0000 -0.0405 0.2745)
+(0.0030 -0.0405 0.2745)
+(0.0060 -0.0405 0.2745)
+(-0.0060 -0.0375 0.2745)
+(-0.0030 -0.0375 0.2745)
+(0.0000 -0.0375 0.2745)
+(0.0030 -0.0375 0.2745)
+(0.0060 -0.0375 0.2745)
+(-0.0060 -0.0345 0.2745)
+(-0.0030 -0.0345 0.2745)
+(0.0000 -0.0345 0.2745)
+(0.0030 -0.0345 0.2745)
+(0.0060 -0.0345 0.2745)
+(-0.0060 -0.0315 0.2745)
+(-0.0030 -0.0315 0.2745)
+(0.0000 -0.0315 0.2745)
+(0.0030 -0.0315 0.2745)
+(0.0060 -0.0315 0.2745)
+(-0.0060 -0.0285 0.2745)
+(-0.0030 -0.0285 0.2745)
+(0.0000 -0.0285 0.2745)
+(0.0030 -0.0285 0.2745)
+(0.0060 -0.0285 0.2745)
+(-0.0060 -0.0255 0.2745)
+(-0.0030 -0.0255 0.2745)
+(0.0000 -0.0255 0.2745)
+(0.0030 -0.0255 0.2745)
+(0.0060 -0.0255 0.2745)
+(-0.0060 -0.0225 0.2745)
+(-0.0030 -0.0225 0.2745)
+(0.0000 -0.0225 0.2745)
+(0.0030 -0.0225 0.2745)
+(0.0060 -0.0225 0.2745)
+(-0.0060 -0.0195 0.2745)
+(-0.0030 -0.0195 0.2745)
+(0.0000 -0.0195 0.2745)
+(0.0030 -0.0195 0.2745)
+(0.0060 -0.0195 0.2745)
+(-0.0060 -0.0165 0.2745)
+(-0.0030 -0.0165 0.2745)
+(0.0000 -0.0165 0.2745)
+(0.0030 -0.0165 0.2745)
+(0.0060 -0.0165 0.2745)
+(-0.0060 -0.0135 0.2745)
+(-0.0030 -0.0135 0.2745)
+(0.0000 -0.0135 0.2745)
+(0.0030 -0.0135 0.2745)
+(0.0060 -0.0135 0.2745)
+(-0.0060 -0.0105 0.2745)
+(-0.0030 -0.0105 0.2745)
+(0.0000 -0.0105 0.2745)
+(0.0030 -0.0105 0.2745)
+(0.0060 -0.0105 0.2745)
+(-0.0060 -0.0075 0.2745)
+(-0.0030 -0.0075 0.2745)
+(0.0000 -0.0075 0.2745)
+(0.0030 -0.0075 0.2745)
+(0.0060 -0.0075 0.2745)
+(-0.0060 -0.0045 0.2745)
+(-0.0030 -0.0045 0.2745)
+(0.0000 -0.0045 0.2745)
+(0.0030 -0.0045 0.2745)
+(0.0060 -0.0045 0.2745)
+(-0.0060 -0.0015 0.2745)
+(-0.0030 -0.0015 0.2745)
+(0.0000 -0.0015 0.2745)
+(0.0030 -0.0015 0.2745)
+(0.0060 -0.0015 0.2745)
+(-0.0060 0.0015 0.2745)
+(-0.0030 0.0015 0.2745)
+(0.0000 0.0015 0.2745)
+(0.0030 0.0015 0.2745)
+(0.0060 0.0015 0.2745)
+(-0.0060 0.0045 0.2745)
+(-0.0030 0.0045 0.2745)
+(0.0000 0.0045 0.2745)
+(0.0030 0.0045 0.2745)
+(0.0060 0.0045 0.2745)
+(-0.0060 0.0075 0.2745)
+(-0.0030 0.0075 0.2745)
+(0.0000 0.0075 0.2745)
+(0.0030 0.0075 0.2745)
+(0.0060 0.0075 0.2745)
+(-0.0060 0.0105 0.2745)
+(-0.0030 0.0105 0.2745)
+(0.0000 0.0105 0.2745)
+(0.0030 0.0105 0.2745)
+(0.0060 0.0105 0.2745)
+(-0.0060 0.0135 0.2745)
+(-0.0030 0.0135 0.2745)
+(0.0000 0.0135 0.2745)
+(0.0030 0.0135 0.2745)
+(0.0060 0.0135 0.2745)
+(-0.0060 0.0165 0.2745)
+(-0.0030 0.0165 0.2745)
+(0.0000 0.0165 0.2745)
+(0.0030 0.0165 0.2745)
+(0.0060 0.0165 0.2745)
+(-0.0060 0.0195 0.2745)
+(-0.0030 0.0195 0.2745)
+(0.0000 0.0195 0.2745)
+(0.0030 0.0195 0.2745)
+(0.0060 0.0195 0.2745)
+(-0.0060 0.0225 0.2745)
+(-0.0030 0.0225 0.2745)
+(0.0000 0.0225 0.2745)
+(0.0030 0.0225 0.2745)
+(0.0060 0.0225 0.2745)
+(-0.0060 0.0255 0.2745)
+(-0.0030 0.0255 0.2745)
+(0.0000 0.0255 0.2745)
+(0.0030 0.0255 0.2745)
+(0.0060 0.0255 0.2745)
+(-0.0060 0.0285 0.2745)
+(-0.0030 0.0285 0.2745)
+(0.0000 0.0285 0.2745)
+(0.0030 0.0285 0.2745)
+(0.0060 0.0285 0.2745)
+(-0.0060 0.0315 0.2745)
+(-0.0030 0.0315 0.2745)
+(0.0000 0.0315 0.2745)
+(0.0030 0.0315 0.2745)
+(0.0060 0.0315 0.2745)
+(-0.0060 0.0345 0.2745)
+(-0.0030 0.0345 0.2745)
+(0.0000 0.0345 0.2745)
+(0.0030 0.0345 0.2745)
+(0.0060 0.0345 0.2745)
+(-0.0060 0.0375 0.2745)
+(-0.0030 0.0375 0.2745)
+(0.0000 0.0375 0.2745)
+(0.0030 0.0375 0.2745)
+(0.0060 0.0375 0.2745)
+(-0.0060 0.0405 0.2745)
+(-0.0030 0.0405 0.2745)
+(0.0000 0.0405 0.2745)
+(0.0030 0.0405 0.2745)
+(0.0060 0.0405 0.2745)
+(-0.0060 0.0435 0.2745)
+(-0.0030 0.0435 0.2745)
+(0.0000 0.0435 0.2745)
+(0.0030 0.0435 0.2745)
+(0.0060 0.0435 0.2745)
+(-0.0060 0.0465 0.2745)
+(-0.0030 0.0465 0.2745)
+(0.0000 0.0465 0.2745)
+(0.0030 0.0465 0.2745)
+(0.0060 0.0465 0.2745)
+(-0.0060 0.0495 0.2745)
+(-0.0030 0.0495 0.2745)
+(0.0000 0.0495 0.2745)
+(0.0030 0.0495 0.2745)
+(0.0060 0.0495 0.2745)
+(-0.0060 0.0525 0.2745)
+(-0.0030 0.0525 0.2745)
+(0.0000 0.0525 0.2745)
+(0.0030 0.0525 0.2745)
+(0.0060 0.0525 0.2745)
+(-0.0060 0.0555 0.2745)
+(-0.0030 0.0555 0.2745)
+(0.0000 0.0555 0.2745)
+(0.0030 0.0555 0.2745)
+(0.0060 0.0555 0.2745)
+(-0.0060 0.0585 0.2745)
+(-0.0030 0.0585 0.2745)
+(0.0000 0.0585 0.2745)
+(0.0030 0.0585 0.2745)
+(0.0060 0.0585 0.2745)
+(-0.0060 0.0615 0.2745)
+(-0.0030 0.0615 0.2745)
+(0.0000 0.0615 0.2745)
+(0.0030 0.0615 0.2745)
+(0.0060 0.0615 0.2745)
+(-0.0060 0.0645 0.2745)
+(-0.0030 0.0645 0.2745)
+(0.0000 0.0645 0.2745)
+(0.0030 0.0645 0.2745)
+(0.0060 0.0645 0.2745)
+(-0.0060 0.0675 0.2745)
+(-0.0030 0.0675 0.2745)
+(0.0000 0.0675 0.2745)
+(0.0030 0.0675 0.2745)
+(0.0060 0.0675 0.2745)
+(-0.0060 0.0705 0.2745)
+(-0.0030 0.0705 0.2745)
+(0.0000 0.0705 0.2745)
+(0.0030 0.0705 0.2745)
+(0.0060 0.0705 0.2745)
+(-0.0060 0.0735 0.2745)
+(-0.0030 0.0735 0.2745)
+(0.0000 0.0735 0.2745)
+(0.0030 0.0735 0.2745)
+(0.0060 0.0735 0.2745)
+(-0.0060 -0.0735 0.2775)
+(-0.0030 -0.0735 0.2775)
+(0.0000 -0.0735 0.2775)
+(0.0030 -0.0735 0.2775)
+(0.0060 -0.0735 0.2775)
+(-0.0060 -0.0705 0.2775)
+(-0.0030 -0.0705 0.2775)
+(0.0000 -0.0705 0.2775)
+(0.0030 -0.0705 0.2775)
+(0.0060 -0.0705 0.2775)
+(-0.0060 -0.0675 0.2775)
+(-0.0030 -0.0675 0.2775)
+(0.0000 -0.0675 0.2775)
+(0.0030 -0.0675 0.2775)
+(0.0060 -0.0675 0.2775)
+(-0.0060 -0.0645 0.2775)
+(-0.0030 -0.0645 0.2775)
+(0.0000 -0.0645 0.2775)
+(0.0030 -0.0645 0.2775)
+(0.0060 -0.0645 0.2775)
+(-0.0060 -0.0615 0.2775)
+(-0.0030 -0.0615 0.2775)
+(0.0000 -0.0615 0.2775)
+(0.0030 -0.0615 0.2775)
+(0.0060 -0.0615 0.2775)
+(-0.0060 -0.0585 0.2775)
+(-0.0030 -0.0585 0.2775)
+(0.0000 -0.0585 0.2775)
+(0.0030 -0.0585 0.2775)
+(0.0060 -0.0585 0.2775)
+(-0.0060 -0.0555 0.2775)
+(-0.0030 -0.0555 0.2775)
+(0.0000 -0.0555 0.2775)
+(0.0030 -0.0555 0.2775)
+(0.0060 -0.0555 0.2775)
+(-0.0060 -0.0525 0.2775)
+(-0.0030 -0.0525 0.2775)
+(0.0000 -0.0525 0.2775)
+(0.0030 -0.0525 0.2775)
+(0.0060 -0.0525 0.2775)
+(-0.0060 -0.0495 0.2775)
+(-0.0030 -0.0495 0.2775)
+(0.0000 -0.0495 0.2775)
+(0.0030 -0.0495 0.2775)
+(0.0060 -0.0495 0.2775)
+(-0.0060 -0.0465 0.2775)
+(-0.0030 -0.0465 0.2775)
+(0.0000 -0.0465 0.2775)
+(0.0030 -0.0465 0.2775)
+(0.0060 -0.0465 0.2775)
+(-0.0060 -0.0435 0.2775)
+(-0.0030 -0.0435 0.2775)
+(0.0000 -0.0435 0.2775)
+(0.0030 -0.0435 0.2775)
+(0.0060 -0.0435 0.2775)
+(-0.0060 -0.0405 0.2775)
+(-0.0030 -0.0405 0.2775)
+(0.0000 -0.0405 0.2775)
+(0.0030 -0.0405 0.2775)
+(0.0060 -0.0405 0.2775)
+(-0.0060 -0.0375 0.2775)
+(-0.0030 -0.0375 0.2775)
+(0.0000 -0.0375 0.2775)
+(0.0030 -0.0375 0.2775)
+(0.0060 -0.0375 0.2775)
+(-0.0060 -0.0345 0.2775)
+(-0.0030 -0.0345 0.2775)
+(0.0000 -0.0345 0.2775)
+(0.0030 -0.0345 0.2775)
+(0.0060 -0.0345 0.2775)
+(-0.0060 -0.0315 0.2775)
+(-0.0030 -0.0315 0.2775)
+(0.0000 -0.0315 0.2775)
+(0.0030 -0.0315 0.2775)
+(0.0060 -0.0315 0.2775)
+(-0.0060 -0.0285 0.2775)
+(-0.0030 -0.0285 0.2775)
+(0.0000 -0.0285 0.2775)
+(0.0030 -0.0285 0.2775)
+(0.0060 -0.0285 0.2775)
+(-0.0060 -0.0255 0.2775)
+(-0.0030 -0.0255 0.2775)
+(0.0000 -0.0255 0.2775)
+(0.0030 -0.0255 0.2775)
+(0.0060 -0.0255 0.2775)
+(-0.0060 -0.0225 0.2775)
+(-0.0030 -0.0225 0.2775)
+(0.0000 -0.0225 0.2775)
+(0.0030 -0.0225 0.2775)
+(0.0060 -0.0225 0.2775)
+(-0.0060 -0.0195 0.2775)
+(-0.0030 -0.0195 0.2775)
+(0.0000 -0.0195 0.2775)
+(0.0030 -0.0195 0.2775)
+(0.0060 -0.0195 0.2775)
+(-0.0060 -0.0165 0.2775)
+(-0.0030 -0.0165 0.2775)
+(0.0000 -0.0165 0.2775)
+(0.0030 -0.0165 0.2775)
+(0.0060 -0.0165 0.2775)
+(-0.0060 -0.0135 0.2775)
+(-0.0030 -0.0135 0.2775)
+(0.0000 -0.0135 0.2775)
+(0.0030 -0.0135 0.2775)
+(0.0060 -0.0135 0.2775)
+(-0.0060 -0.0105 0.2775)
+(-0.0030 -0.0105 0.2775)
+(0.0000 -0.0105 0.2775)
+(0.0030 -0.0105 0.2775)
+(0.0060 -0.0105 0.2775)
+(-0.0060 -0.0075 0.2775)
+(-0.0030 -0.0075 0.2775)
+(0.0000 -0.0075 0.2775)
+(0.0030 -0.0075 0.2775)
+(0.0060 -0.0075 0.2775)
+(-0.0060 -0.0045 0.2775)
+(-0.0030 -0.0045 0.2775)
+(0.0000 -0.0045 0.2775)
+(0.0030 -0.0045 0.2775)
+(0.0060 -0.0045 0.2775)
+(-0.0060 -0.0015 0.2775)
+(-0.0030 -0.0015 0.2775)
+(0.0000 -0.0015 0.2775)
+(0.0030 -0.0015 0.2775)
+(0.0060 -0.0015 0.2775)
+(-0.0060 0.0015 0.2775)
+(-0.0030 0.0015 0.2775)
+(0.0000 0.0015 0.2775)
+(0.0030 0.0015 0.2775)
+(0.0060 0.0015 0.2775)
+(-0.0060 0.0045 0.2775)
+(-0.0030 0.0045 0.2775)
+(0.0000 0.0045 0.2775)
+(0.0030 0.0045 0.2775)
+(0.0060 0.0045 0.2775)
+(-0.0060 0.0075 0.2775)
+(-0.0030 0.0075 0.2775)
+(0.0000 0.0075 0.2775)
+(0.0030 0.0075 0.2775)
+(0.0060 0.0075 0.2775)
+(-0.0060 0.0105 0.2775)
+(-0.0030 0.0105 0.2775)
+(0.0000 0.0105 0.2775)
+(0.0030 0.0105 0.2775)
+(0.0060 0.0105 0.2775)
+(-0.0060 0.0135 0.2775)
+(-0.0030 0.0135 0.2775)
+(0.0000 0.0135 0.2775)
+(0.0030 0.0135 0.2775)
+(0.0060 0.0135 0.2775)
+(-0.0060 0.0165 0.2775)
+(-0.0030 0.0165 0.2775)
+(0.0000 0.0165 0.2775)
+(0.0030 0.0165 0.2775)
+(0.0060 0.0165 0.2775)
+(-0.0060 0.0195 0.2775)
+(-0.0030 0.0195 0.2775)
+(0.0000 0.0195 0.2775)
+(0.0030 0.0195 0.2775)
+(0.0060 0.0195 0.2775)
+(-0.0060 0.0225 0.2775)
+(-0.0030 0.0225 0.2775)
+(0.0000 0.0225 0.2775)
+(0.0030 0.0225 0.2775)
+(0.0060 0.0225 0.2775)
+(-0.0060 0.0255 0.2775)
+(-0.0030 0.0255 0.2775)
+(0.0000 0.0255 0.2775)
+(0.0030 0.0255 0.2775)
+(0.0060 0.0255 0.2775)
+(-0.0060 0.0285 0.2775)
+(-0.0030 0.0285 0.2775)
+(0.0000 0.0285 0.2775)
+(0.0030 0.0285 0.2775)
+(0.0060 0.0285 0.2775)
+(-0.0060 0.0315 0.2775)
+(-0.0030 0.0315 0.2775)
+(0.0000 0.0315 0.2775)
+(0.0030 0.0315 0.2775)
+(0.0060 0.0315 0.2775)
+(-0.0060 0.0345 0.2775)
+(-0.0030 0.0345 0.2775)
+(0.0000 0.0345 0.2775)
+(0.0030 0.0345 0.2775)
+(0.0060 0.0345 0.2775)
+(-0.0060 0.0375 0.2775)
+(-0.0030 0.0375 0.2775)
+(0.0000 0.0375 0.2775)
+(0.0030 0.0375 0.2775)
+(0.0060 0.0375 0.2775)
+(-0.0060 0.0405 0.2775)
+(-0.0030 0.0405 0.2775)
+(0.0000 0.0405 0.2775)
+(0.0030 0.0405 0.2775)
+(0.0060 0.0405 0.2775)
+(-0.0060 0.0435 0.2775)
+(-0.0030 0.0435 0.2775)
+(0.0000 0.0435 0.2775)
+(0.0030 0.0435 0.2775)
+(0.0060 0.0435 0.2775)
+(-0.0060 0.0465 0.2775)
+(-0.0030 0.0465 0.2775)
+(0.0000 0.0465 0.2775)
+(0.0030 0.0465 0.2775)
+(0.0060 0.0465 0.2775)
+(-0.0060 0.0495 0.2775)
+(-0.0030 0.0495 0.2775)
+(0.0000 0.0495 0.2775)
+(0.0030 0.0495 0.2775)
+(0.0060 0.0495 0.2775)
+(-0.0060 0.0525 0.2775)
+(-0.0030 0.0525 0.2775)
+(0.0000 0.0525 0.2775)
+(0.0030 0.0525 0.2775)
+(0.0060 0.0525 0.2775)
+(-0.0060 0.0555 0.2775)
+(-0.0030 0.0555 0.2775)
+(0.0000 0.0555 0.2775)
+(0.0030 0.0555 0.2775)
+(0.0060 0.0555 0.2775)
+(-0.0060 0.0585 0.2775)
+(-0.0030 0.0585 0.2775)
+(0.0000 0.0585 0.2775)
+(0.0030 0.0585 0.2775)
+(0.0060 0.0585 0.2775)
+(-0.0060 0.0615 0.2775)
+(-0.0030 0.0615 0.2775)
+(0.0000 0.0615 0.2775)
+(0.0030 0.0615 0.2775)
+(0.0060 0.0615 0.2775)
+(-0.0060 0.0645 0.2775)
+(-0.0030 0.0645 0.2775)
+(0.0000 0.0645 0.2775)
+(0.0030 0.0645 0.2775)
+(0.0060 0.0645 0.2775)
+(-0.0060 0.0675 0.2775)
+(-0.0030 0.0675 0.2775)
+(0.0000 0.0675 0.2775)
+(0.0030 0.0675 0.2775)
+(0.0060 0.0675 0.2775)
+(-0.0060 0.0705 0.2775)
+(-0.0030 0.0705 0.2775)
+(0.0000 0.0705 0.2775)
+(0.0030 0.0705 0.2775)
+(0.0060 0.0705 0.2775)
+(-0.0060 0.0735 0.2775)
+(-0.0030 0.0735 0.2775)
+(0.0000 0.0735 0.2775)
+(0.0030 0.0735 0.2775)
+(0.0060 0.0735 0.2775)
+(-0.0060 -0.0735 0.2805)
+(-0.0030 -0.0735 0.2805)
+(0.0000 -0.0735 0.2805)
+(0.0030 -0.0735 0.2805)
+(0.0060 -0.0735 0.2805)
+(-0.0060 -0.0705 0.2805)
+(-0.0030 -0.0705 0.2805)
+(0.0000 -0.0705 0.2805)
+(0.0030 -0.0705 0.2805)
+(0.0060 -0.0705 0.2805)
+(-0.0060 -0.0675 0.2805)
+(-0.0030 -0.0675 0.2805)
+(0.0000 -0.0675 0.2805)
+(0.0030 -0.0675 0.2805)
+(0.0060 -0.0675 0.2805)
+(-0.0060 -0.0645 0.2805)
+(-0.0030 -0.0645 0.2805)
+(0.0000 -0.0645 0.2805)
+(0.0030 -0.0645 0.2805)
+(0.0060 -0.0645 0.2805)
+(-0.0060 -0.0615 0.2805)
+(-0.0030 -0.0615 0.2805)
+(0.0000 -0.0615 0.2805)
+(0.0030 -0.0615 0.2805)
+(0.0060 -0.0615 0.2805)
+(-0.0060 -0.0585 0.2805)
+(-0.0030 -0.0585 0.2805)
+(0.0000 -0.0585 0.2805)
+(0.0030 -0.0585 0.2805)
+(0.0060 -0.0585 0.2805)
+(-0.0060 -0.0555 0.2805)
+(-0.0030 -0.0555 0.2805)
+(0.0000 -0.0555 0.2805)
+(0.0030 -0.0555 0.2805)
+(0.0060 -0.0555 0.2805)
+(-0.0060 -0.0525 0.2805)
+(-0.0030 -0.0525 0.2805)
+(0.0000 -0.0525 0.2805)
+(0.0030 -0.0525 0.2805)
+(0.0060 -0.0525 0.2805)
+(-0.0060 -0.0495 0.2805)
+(-0.0030 -0.0495 0.2805)
+(0.0000 -0.0495 0.2805)
+(0.0030 -0.0495 0.2805)
+(0.0060 -0.0495 0.2805)
+(-0.0060 -0.0465 0.2805)
+(-0.0030 -0.0465 0.2805)
+(0.0000 -0.0465 0.2805)
+(0.0030 -0.0465 0.2805)
+(0.0060 -0.0465 0.2805)
+(-0.0060 -0.0435 0.2805)
+(-0.0030 -0.0435 0.2805)
+(0.0000 -0.0435 0.2805)
+(0.0030 -0.0435 0.2805)
+(0.0060 -0.0435 0.2805)
+(-0.0060 -0.0405 0.2805)
+(-0.0030 -0.0405 0.2805)
+(0.0000 -0.0405 0.2805)
+(0.0030 -0.0405 0.2805)
+(0.0060 -0.0405 0.2805)
+(-0.0060 -0.0375 0.2805)
+(-0.0030 -0.0375 0.2805)
+(0.0000 -0.0375 0.2805)
+(0.0030 -0.0375 0.2805)
+(0.0060 -0.0375 0.2805)
+(-0.0060 -0.0345 0.2805)
+(-0.0030 -0.0345 0.2805)
+(0.0000 -0.0345 0.2805)
+(0.0030 -0.0345 0.2805)
+(0.0060 -0.0345 0.2805)
+(-0.0060 -0.0315 0.2805)
+(-0.0030 -0.0315 0.2805)
+(0.0000 -0.0315 0.2805)
+(0.0030 -0.0315 0.2805)
+(0.0060 -0.0315 0.2805)
+(-0.0060 -0.0285 0.2805)
+(-0.0030 -0.0285 0.2805)
+(0.0000 -0.0285 0.2805)
+(0.0030 -0.0285 0.2805)
+(0.0060 -0.0285 0.2805)
+(-0.0060 -0.0255 0.2805)
+(-0.0030 -0.0255 0.2805)
+(0.0000 -0.0255 0.2805)
+(0.0030 -0.0255 0.2805)
+(0.0060 -0.0255 0.2805)
+(-0.0060 -0.0225 0.2805)
+(-0.0030 -0.0225 0.2805)
+(0.0000 -0.0225 0.2805)
+(0.0030 -0.0225 0.2805)
+(0.0060 -0.0225 0.2805)
+(-0.0060 -0.0195 0.2805)
+(-0.0030 -0.0195 0.2805)
+(0.0000 -0.0195 0.2805)
+(0.0030 -0.0195 0.2805)
+(0.0060 -0.0195 0.2805)
+(-0.0060 -0.0165 0.2805)
+(-0.0030 -0.0165 0.2805)
+(0.0000 -0.0165 0.2805)
+(0.0030 -0.0165 0.2805)
+(0.0060 -0.0165 0.2805)
+(-0.0060 -0.0135 0.2805)
+(-0.0030 -0.0135 0.2805)
+(0.0000 -0.0135 0.2805)
+(0.0030 -0.0135 0.2805)
+(0.0060 -0.0135 0.2805)
+(-0.0060 -0.0105 0.2805)
+(-0.0030 -0.0105 0.2805)
+(0.0000 -0.0105 0.2805)
+(0.0030 -0.0105 0.2805)
+(0.0060 -0.0105 0.2805)
+(-0.0060 -0.0075 0.2805)
+(-0.0030 -0.0075 0.2805)
+(0.0000 -0.0075 0.2805)
+(0.0030 -0.0075 0.2805)
+(0.0060 -0.0075 0.2805)
+(-0.0060 -0.0045 0.2805)
+(-0.0030 -0.0045 0.2805)
+(0.0000 -0.0045 0.2805)
+(0.0030 -0.0045 0.2805)
+(0.0060 -0.0045 0.2805)
+(-0.0060 -0.0015 0.2805)
+(-0.0030 -0.0015 0.2805)
+(0.0000 -0.0015 0.2805)
+(0.0030 -0.0015 0.2805)
+(0.0060 -0.0015 0.2805)
+(-0.0060 0.0015 0.2805)
+(-0.0030 0.0015 0.2805)
+(0.0000 0.0015 0.2805)
+(0.0030 0.0015 0.2805)
+(0.0060 0.0015 0.2805)
+(-0.0060 0.0045 0.2805)
+(-0.0030 0.0045 0.2805)
+(0.0000 0.0045 0.2805)
+(0.0030 0.0045 0.2805)
+(0.0060 0.0045 0.2805)
+(-0.0060 0.0075 0.2805)
+(-0.0030 0.0075 0.2805)
+(0.0000 0.0075 0.2805)
+(0.0030 0.0075 0.2805)
+(0.0060 0.0075 0.2805)
+(-0.0060 0.0105 0.2805)
+(-0.0030 0.0105 0.2805)
+(0.0000 0.0105 0.2805)
+(0.0030 0.0105 0.2805)
+(0.0060 0.0105 0.2805)
+(-0.0060 0.0135 0.2805)
+(-0.0030 0.0135 0.2805)
+(0.0000 0.0135 0.2805)
+(0.0030 0.0135 0.2805)
+(0.0060 0.0135 0.2805)
+(-0.0060 0.0165 0.2805)
+(-0.0030 0.0165 0.2805)
+(0.0000 0.0165 0.2805)
+(0.0030 0.0165 0.2805)
+(0.0060 0.0165 0.2805)
+(-0.0060 0.0195 0.2805)
+(-0.0030 0.0195 0.2805)
+(0.0000 0.0195 0.2805)
+(0.0030 0.0195 0.2805)
+(0.0060 0.0195 0.2805)
+(-0.0060 0.0225 0.2805)
+(-0.0030 0.0225 0.2805)
+(0.0000 0.0225 0.2805)
+(0.0030 0.0225 0.2805)
+(0.0060 0.0225 0.2805)
+(-0.0060 0.0255 0.2805)
+(-0.0030 0.0255 0.2805)
+(0.0000 0.0255 0.2805)
+(0.0030 0.0255 0.2805)
+(0.0060 0.0255 0.2805)
+(-0.0060 0.0285 0.2805)
+(-0.0030 0.0285 0.2805)
+(0.0000 0.0285 0.2805)
+(0.0030 0.0285 0.2805)
+(0.0060 0.0285 0.2805)
+(-0.0060 0.0315 0.2805)
+(-0.0030 0.0315 0.2805)
+(0.0000 0.0315 0.2805)
+(0.0030 0.0315 0.2805)
+(0.0060 0.0315 0.2805)
+(-0.0060 0.0345 0.2805)
+(-0.0030 0.0345 0.2805)
+(0.0000 0.0345 0.2805)
+(0.0030 0.0345 0.2805)
+(0.0060 0.0345 0.2805)
+(-0.0060 0.0375 0.2805)
+(-0.0030 0.0375 0.2805)
+(0.0000 0.0375 0.2805)
+(0.0030 0.0375 0.2805)
+(0.0060 0.0375 0.2805)
+(-0.0060 0.0405 0.2805)
+(-0.0030 0.0405 0.2805)
+(0.0000 0.0405 0.2805)
+(0.0030 0.0405 0.2805)
+(0.0060 0.0405 0.2805)
+(-0.0060 0.0435 0.2805)
+(-0.0030 0.0435 0.2805)
+(0.0000 0.0435 0.2805)
+(0.0030 0.0435 0.2805)
+(0.0060 0.0435 0.2805)
+(-0.0060 0.0465 0.2805)
+(-0.0030 0.0465 0.2805)
+(0.0000 0.0465 0.2805)
+(0.0030 0.0465 0.2805)
+(0.0060 0.0465 0.2805)
+(-0.0060 0.0495 0.2805)
+(-0.0030 0.0495 0.2805)
+(0.0000 0.0495 0.2805)
+(0.0030 0.0495 0.2805)
+(0.0060 0.0495 0.2805)
+(-0.0060 0.0525 0.2805)
+(-0.0030 0.0525 0.2805)
+(0.0000 0.0525 0.2805)
+(0.0030 0.0525 0.2805)
+(0.0060 0.0525 0.2805)
+(-0.0060 0.0555 0.2805)
+(-0.0030 0.0555 0.2805)
+(0.0000 0.0555 0.2805)
+(0.0030 0.0555 0.2805)
+(0.0060 0.0555 0.2805)
+(-0.0060 0.0585 0.2805)
+(-0.0030 0.0585 0.2805)
+(0.0000 0.0585 0.2805)
+(0.0030 0.0585 0.2805)
+(0.0060 0.0585 0.2805)
+(-0.0060 0.0615 0.2805)
+(-0.0030 0.0615 0.2805)
+(0.0000 0.0615 0.2805)
+(0.0030 0.0615 0.2805)
+(0.0060 0.0615 0.2805)
+(-0.0060 0.0645 0.2805)
+(-0.0030 0.0645 0.2805)
+(0.0000 0.0645 0.2805)
+(0.0030 0.0645 0.2805)
+(0.0060 0.0645 0.2805)
+(-0.0060 0.0675 0.2805)
+(-0.0030 0.0675 0.2805)
+(0.0000 0.0675 0.2805)
+(0.0030 0.0675 0.2805)
+(0.0060 0.0675 0.2805)
+(-0.0060 0.0705 0.2805)
+(-0.0030 0.0705 0.2805)
+(0.0000 0.0705 0.2805)
+(0.0030 0.0705 0.2805)
+(0.0060 0.0705 0.2805)
+(-0.0060 0.0735 0.2805)
+(-0.0030 0.0735 0.2805)
+(0.0000 0.0735 0.2805)
+(0.0030 0.0735 0.2805)
+(0.0060 0.0735 0.2805)
+(-0.0060 -0.0735 0.2835)
+(-0.0030 -0.0735 0.2835)
+(0.0000 -0.0735 0.2835)
+(0.0030 -0.0735 0.2835)
+(0.0060 -0.0735 0.2835)
+(-0.0060 -0.0705 0.2835)
+(-0.0030 -0.0705 0.2835)
+(0.0000 -0.0705 0.2835)
+(0.0030 -0.0705 0.2835)
+(0.0060 -0.0705 0.2835)
+(-0.0060 -0.0675 0.2835)
+(-0.0030 -0.0675 0.2835)
+(0.0000 -0.0675 0.2835)
+(0.0030 -0.0675 0.2835)
+(0.0060 -0.0675 0.2835)
+(-0.0060 -0.0645 0.2835)
+(-0.0030 -0.0645 0.2835)
+(0.0000 -0.0645 0.2835)
+(0.0030 -0.0645 0.2835)
+(0.0060 -0.0645 0.2835)
+(-0.0060 -0.0615 0.2835)
+(-0.0030 -0.0615 0.2835)
+(0.0000 -0.0615 0.2835)
+(0.0030 -0.0615 0.2835)
+(0.0060 -0.0615 0.2835)
+(-0.0060 -0.0585 0.2835)
+(-0.0030 -0.0585 0.2835)
+(0.0000 -0.0585 0.2835)
+(0.0030 -0.0585 0.2835)
+(0.0060 -0.0585 0.2835)
+(-0.0060 -0.0555 0.2835)
+(-0.0030 -0.0555 0.2835)
+(0.0000 -0.0555 0.2835)
+(0.0030 -0.0555 0.2835)
+(0.0060 -0.0555 0.2835)
+(-0.0060 -0.0525 0.2835)
+(-0.0030 -0.0525 0.2835)
+(0.0000 -0.0525 0.2835)
+(0.0030 -0.0525 0.2835)
+(0.0060 -0.0525 0.2835)
+(-0.0060 -0.0495 0.2835)
+(-0.0030 -0.0495 0.2835)
+(0.0000 -0.0495 0.2835)
+(0.0030 -0.0495 0.2835)
+(0.0060 -0.0495 0.2835)
+(-0.0060 -0.0465 0.2835)
+(-0.0030 -0.0465 0.2835)
+(0.0000 -0.0465 0.2835)
+(0.0030 -0.0465 0.2835)
+(0.0060 -0.0465 0.2835)
+(-0.0060 -0.0435 0.2835)
+(-0.0030 -0.0435 0.2835)
+(0.0000 -0.0435 0.2835)
+(0.0030 -0.0435 0.2835)
+(0.0060 -0.0435 0.2835)
+(-0.0060 -0.0405 0.2835)
+(-0.0030 -0.0405 0.2835)
+(0.0000 -0.0405 0.2835)
+(0.0030 -0.0405 0.2835)
+(0.0060 -0.0405 0.2835)
+(-0.0060 -0.0375 0.2835)
+(-0.0030 -0.0375 0.2835)
+(0.0000 -0.0375 0.2835)
+(0.0030 -0.0375 0.2835)
+(0.0060 -0.0375 0.2835)
+(-0.0060 -0.0345 0.2835)
+(-0.0030 -0.0345 0.2835)
+(0.0000 -0.0345 0.2835)
+(0.0030 -0.0345 0.2835)
+(0.0060 -0.0345 0.2835)
+(-0.0060 -0.0315 0.2835)
+(-0.0030 -0.0315 0.2835)
+(0.0000 -0.0315 0.2835)
+(0.0030 -0.0315 0.2835)
+(0.0060 -0.0315 0.2835)
+(-0.0060 -0.0285 0.2835)
+(-0.0030 -0.0285 0.2835)
+(0.0000 -0.0285 0.2835)
+(0.0030 -0.0285 0.2835)
+(0.0060 -0.0285 0.2835)
+(-0.0060 -0.0255 0.2835)
+(-0.0030 -0.0255 0.2835)
+(0.0000 -0.0255 0.2835)
+(0.0030 -0.0255 0.2835)
+(0.0060 -0.0255 0.2835)
+(-0.0060 -0.0225 0.2835)
+(-0.0030 -0.0225 0.2835)
+(0.0000 -0.0225 0.2835)
+(0.0030 -0.0225 0.2835)
+(0.0060 -0.0225 0.2835)
+(-0.0060 -0.0195 0.2835)
+(-0.0030 -0.0195 0.2835)
+(0.0000 -0.0195 0.2835)
+(0.0030 -0.0195 0.2835)
+(0.0060 -0.0195 0.2835)
+(-0.0060 -0.0165 0.2835)
+(-0.0030 -0.0165 0.2835)
+(0.0000 -0.0165 0.2835)
+(0.0030 -0.0165 0.2835)
+(0.0060 -0.0165 0.2835)
+(-0.0060 -0.0135 0.2835)
+(-0.0030 -0.0135 0.2835)
+(0.0000 -0.0135 0.2835)
+(0.0030 -0.0135 0.2835)
+(0.0060 -0.0135 0.2835)
+(-0.0060 -0.0105 0.2835)
+(-0.0030 -0.0105 0.2835)
+(0.0000 -0.0105 0.2835)
+(0.0030 -0.0105 0.2835)
+(0.0060 -0.0105 0.2835)
+(-0.0060 -0.0075 0.2835)
+(-0.0030 -0.0075 0.2835)
+(0.0000 -0.0075 0.2835)
+(0.0030 -0.0075 0.2835)
+(0.0060 -0.0075 0.2835)
+(-0.0060 -0.0045 0.2835)
+(-0.0030 -0.0045 0.2835)
+(0.0000 -0.0045 0.2835)
+(0.0030 -0.0045 0.2835)
+(0.0060 -0.0045 0.2835)
+(-0.0060 -0.0015 0.2835)
+(-0.0030 -0.0015 0.2835)
+(0.0000 -0.0015 0.2835)
+(0.0030 -0.0015 0.2835)
+(0.0060 -0.0015 0.2835)
+(-0.0060 0.0015 0.2835)
+(-0.0030 0.0015 0.2835)
+(0.0000 0.0015 0.2835)
+(0.0030 0.0015 0.2835)
+(0.0060 0.0015 0.2835)
+(-0.0060 0.0045 0.2835)
+(-0.0030 0.0045 0.2835)
+(0.0000 0.0045 0.2835)
+(0.0030 0.0045 0.2835)
+(0.0060 0.0045 0.2835)
+(-0.0060 0.0075 0.2835)
+(-0.0030 0.0075 0.2835)
+(0.0000 0.0075 0.2835)
+(0.0030 0.0075 0.2835)
+(0.0060 0.0075 0.2835)
+(-0.0060 0.0105 0.2835)
+(-0.0030 0.0105 0.2835)
+(0.0000 0.0105 0.2835)
+(0.0030 0.0105 0.2835)
+(0.0060 0.0105 0.2835)
+(-0.0060 0.0135 0.2835)
+(-0.0030 0.0135 0.2835)
+(0.0000 0.0135 0.2835)
+(0.0030 0.0135 0.2835)
+(0.0060 0.0135 0.2835)
+(-0.0060 0.0165 0.2835)
+(-0.0030 0.0165 0.2835)
+(0.0000 0.0165 0.2835)
+(0.0030 0.0165 0.2835)
+(0.0060 0.0165 0.2835)
+(-0.0060 0.0195 0.2835)
+(-0.0030 0.0195 0.2835)
+(0.0000 0.0195 0.2835)
+(0.0030 0.0195 0.2835)
+(0.0060 0.0195 0.2835)
+(-0.0060 0.0225 0.2835)
+(-0.0030 0.0225 0.2835)
+(0.0000 0.0225 0.2835)
+(0.0030 0.0225 0.2835)
+(0.0060 0.0225 0.2835)
+(-0.0060 0.0255 0.2835)
+(-0.0030 0.0255 0.2835)
+(0.0000 0.0255 0.2835)
+(0.0030 0.0255 0.2835)
+(0.0060 0.0255 0.2835)
+(-0.0060 0.0285 0.2835)
+(-0.0030 0.0285 0.2835)
+(0.0000 0.0285 0.2835)
+(0.0030 0.0285 0.2835)
+(0.0060 0.0285 0.2835)
+(-0.0060 0.0315 0.2835)
+(-0.0030 0.0315 0.2835)
+(0.0000 0.0315 0.2835)
+(0.0030 0.0315 0.2835)
+(0.0060 0.0315 0.2835)
+(-0.0060 0.0345 0.2835)
+(-0.0030 0.0345 0.2835)
+(0.0000 0.0345 0.2835)
+(0.0030 0.0345 0.2835)
+(0.0060 0.0345 0.2835)
+(-0.0060 0.0375 0.2835)
+(-0.0030 0.0375 0.2835)
+(0.0000 0.0375 0.2835)
+(0.0030 0.0375 0.2835)
+(0.0060 0.0375 0.2835)
+(-0.0060 0.0405 0.2835)
+(-0.0030 0.0405 0.2835)
+(0.0000 0.0405 0.2835)
+(0.0030 0.0405 0.2835)
+(0.0060 0.0405 0.2835)
+(-0.0060 0.0435 0.2835)
+(-0.0030 0.0435 0.2835)
+(0.0000 0.0435 0.2835)
+(0.0030 0.0435 0.2835)
+(0.0060 0.0435 0.2835)
+(-0.0060 0.0465 0.2835)
+(-0.0030 0.0465 0.2835)
+(0.0000 0.0465 0.2835)
+(0.0030 0.0465 0.2835)
+(0.0060 0.0465 0.2835)
+(-0.0060 0.0495 0.2835)
+(-0.0030 0.0495 0.2835)
+(0.0000 0.0495 0.2835)
+(0.0030 0.0495 0.2835)
+(0.0060 0.0495 0.2835)
+(-0.0060 0.0525 0.2835)
+(-0.0030 0.0525 0.2835)
+(0.0000 0.0525 0.2835)
+(0.0030 0.0525 0.2835)
+(0.0060 0.0525 0.2835)
+(-0.0060 0.0555 0.2835)
+(-0.0030 0.0555 0.2835)
+(0.0000 0.0555 0.2835)
+(0.0030 0.0555 0.2835)
+(0.0060 0.0555 0.2835)
+(-0.0060 0.0585 0.2835)
+(-0.0030 0.0585 0.2835)
+(0.0000 0.0585 0.2835)
+(0.0030 0.0585 0.2835)
+(0.0060 0.0585 0.2835)
+(-0.0060 0.0615 0.2835)
+(-0.0030 0.0615 0.2835)
+(0.0000 0.0615 0.2835)
+(0.0030 0.0615 0.2835)
+(0.0060 0.0615 0.2835)
+(-0.0060 0.0645 0.2835)
+(-0.0030 0.0645 0.2835)
+(0.0000 0.0645 0.2835)
+(0.0030 0.0645 0.2835)
+(0.0060 0.0645 0.2835)
+(-0.0060 0.0675 0.2835)
+(-0.0030 0.0675 0.2835)
+(0.0000 0.0675 0.2835)
+(0.0030 0.0675 0.2835)
+(0.0060 0.0675 0.2835)
+(-0.0060 0.0705 0.2835)
+(-0.0030 0.0705 0.2835)
+(0.0000 0.0705 0.2835)
+(0.0030 0.0705 0.2835)
+(0.0060 0.0705 0.2835)
+(-0.0060 0.0735 0.2835)
+(-0.0030 0.0735 0.2835)
+(0.0000 0.0735 0.2835)
+(0.0030 0.0735 0.2835)
+(0.0060 0.0735 0.2835)
+(-0.0060 -0.0735 0.2865)
+(-0.0030 -0.0735 0.2865)
+(0.0000 -0.0735 0.2865)
+(0.0030 -0.0735 0.2865)
+(0.0060 -0.0735 0.2865)
+(-0.0060 -0.0705 0.2865)
+(-0.0030 -0.0705 0.2865)
+(0.0000 -0.0705 0.2865)
+(0.0030 -0.0705 0.2865)
+(0.0060 -0.0705 0.2865)
+(-0.0060 -0.0675 0.2865)
+(-0.0030 -0.0675 0.2865)
+(0.0000 -0.0675 0.2865)
+(0.0030 -0.0675 0.2865)
+(0.0060 -0.0675 0.2865)
+(-0.0060 -0.0645 0.2865)
+(-0.0030 -0.0645 0.2865)
+(0.0000 -0.0645 0.2865)
+(0.0030 -0.0645 0.2865)
+(0.0060 -0.0645 0.2865)
+(-0.0060 -0.0615 0.2865)
+(-0.0030 -0.0615 0.2865)
+(0.0000 -0.0615 0.2865)
+(0.0030 -0.0615 0.2865)
+(0.0060 -0.0615 0.2865)
+(-0.0060 -0.0585 0.2865)
+(-0.0030 -0.0585 0.2865)
+(0.0000 -0.0585 0.2865)
+(0.0030 -0.0585 0.2865)
+(0.0060 -0.0585 0.2865)
+(-0.0060 -0.0555 0.2865)
+(-0.0030 -0.0555 0.2865)
+(0.0000 -0.0555 0.2865)
+(0.0030 -0.0555 0.2865)
+(0.0060 -0.0555 0.2865)
+(-0.0060 -0.0525 0.2865)
+(-0.0030 -0.0525 0.2865)
+(0.0000 -0.0525 0.2865)
+(0.0030 -0.0525 0.2865)
+(0.0060 -0.0525 0.2865)
+(-0.0060 -0.0495 0.2865)
+(-0.0030 -0.0495 0.2865)
+(0.0000 -0.0495 0.2865)
+(0.0030 -0.0495 0.2865)
+(0.0060 -0.0495 0.2865)
+(-0.0060 -0.0465 0.2865)
+(-0.0030 -0.0465 0.2865)
+(0.0000 -0.0465 0.2865)
+(0.0030 -0.0465 0.2865)
+(0.0060 -0.0465 0.2865)
+(-0.0060 -0.0435 0.2865)
+(-0.0030 -0.0435 0.2865)
+(0.0000 -0.0435 0.2865)
+(0.0030 -0.0435 0.2865)
+(0.0060 -0.0435 0.2865)
+(-0.0060 -0.0405 0.2865)
+(-0.0030 -0.0405 0.2865)
+(0.0000 -0.0405 0.2865)
+(0.0030 -0.0405 0.2865)
+(0.0060 -0.0405 0.2865)
+(-0.0060 -0.0375 0.2865)
+(-0.0030 -0.0375 0.2865)
+(0.0000 -0.0375 0.2865)
+(0.0030 -0.0375 0.2865)
+(0.0060 -0.0375 0.2865)
+(-0.0060 -0.0345 0.2865)
+(-0.0030 -0.0345 0.2865)
+(0.0000 -0.0345 0.2865)
+(0.0030 -0.0345 0.2865)
+(0.0060 -0.0345 0.2865)
+(-0.0060 -0.0315 0.2865)
+(-0.0030 -0.0315 0.2865)
+(0.0000 -0.0315 0.2865)
+(0.0030 -0.0315 0.2865)
+(0.0060 -0.0315 0.2865)
+(-0.0060 -0.0285 0.2865)
+(-0.0030 -0.0285 0.2865)
+(0.0000 -0.0285 0.2865)
+(0.0030 -0.0285 0.2865)
+(0.0060 -0.0285 0.2865)
+(-0.0060 -0.0255 0.2865)
+(-0.0030 -0.0255 0.2865)
+(0.0000 -0.0255 0.2865)
+(0.0030 -0.0255 0.2865)
+(0.0060 -0.0255 0.2865)
+(-0.0060 -0.0225 0.2865)
+(-0.0030 -0.0225 0.2865)
+(0.0000 -0.0225 0.2865)
+(0.0030 -0.0225 0.2865)
+(0.0060 -0.0225 0.2865)
+(-0.0060 -0.0195 0.2865)
+(-0.0030 -0.0195 0.2865)
+(0.0000 -0.0195 0.2865)
+(0.0030 -0.0195 0.2865)
+(0.0060 -0.0195 0.2865)
+(-0.0060 -0.0165 0.2865)
+(-0.0030 -0.0165 0.2865)
+(0.0000 -0.0165 0.2865)
+(0.0030 -0.0165 0.2865)
+(0.0060 -0.0165 0.2865)
+(-0.0060 -0.0135 0.2865)
+(-0.0030 -0.0135 0.2865)
+(0.0000 -0.0135 0.2865)
+(0.0030 -0.0135 0.2865)
+(0.0060 -0.0135 0.2865)
+(-0.0060 -0.0105 0.2865)
+(-0.0030 -0.0105 0.2865)
+(0.0000 -0.0105 0.2865)
+(0.0030 -0.0105 0.2865)
+(0.0060 -0.0105 0.2865)
+(-0.0060 -0.0075 0.2865)
+(-0.0030 -0.0075 0.2865)
+(0.0000 -0.0075 0.2865)
+(0.0030 -0.0075 0.2865)
+(0.0060 -0.0075 0.2865)
+(-0.0060 -0.0045 0.2865)
+(-0.0030 -0.0045 0.2865)
+(0.0000 -0.0045 0.2865)
+(0.0030 -0.0045 0.2865)
+(0.0060 -0.0045 0.2865)
+(-0.0060 -0.0015 0.2865)
+(-0.0030 -0.0015 0.2865)
+(0.0000 -0.0015 0.2865)
+(0.0030 -0.0015 0.2865)
+(0.0060 -0.0015 0.2865)
+(-0.0060 0.0015 0.2865)
+(-0.0030 0.0015 0.2865)
+(0.0000 0.0015 0.2865)
+(0.0030 0.0015 0.2865)
+(0.0060 0.0015 0.2865)
+(-0.0060 0.0045 0.2865)
+(-0.0030 0.0045 0.2865)
+(0.0000 0.0045 0.2865)
+(0.0030 0.0045 0.2865)
+(0.0060 0.0045 0.2865)
+(-0.0060 0.0075 0.2865)
+(-0.0030 0.0075 0.2865)
+(0.0000 0.0075 0.2865)
+(0.0030 0.0075 0.2865)
+(0.0060 0.0075 0.2865)
+(-0.0060 0.0105 0.2865)
+(-0.0030 0.0105 0.2865)
+(0.0000 0.0105 0.2865)
+(0.0030 0.0105 0.2865)
+(0.0060 0.0105 0.2865)
+(-0.0060 0.0135 0.2865)
+(-0.0030 0.0135 0.2865)
+(0.0000 0.0135 0.2865)
+(0.0030 0.0135 0.2865)
+(0.0060 0.0135 0.2865)
+(-0.0060 0.0165 0.2865)
+(-0.0030 0.0165 0.2865)
+(0.0000 0.0165 0.2865)
+(0.0030 0.0165 0.2865)
+(0.0060 0.0165 0.2865)
+(-0.0060 0.0195 0.2865)
+(-0.0030 0.0195 0.2865)
+(0.0000 0.0195 0.2865)
+(0.0030 0.0195 0.2865)
+(0.0060 0.0195 0.2865)
+(-0.0060 0.0225 0.2865)
+(-0.0030 0.0225 0.2865)
+(0.0000 0.0225 0.2865)
+(0.0030 0.0225 0.2865)
+(0.0060 0.0225 0.2865)
+(-0.0060 0.0255 0.2865)
+(-0.0030 0.0255 0.2865)
+(0.0000 0.0255 0.2865)
+(0.0030 0.0255 0.2865)
+(0.0060 0.0255 0.2865)
+(-0.0060 0.0285 0.2865)
+(-0.0030 0.0285 0.2865)
+(0.0000 0.0285 0.2865)
+(0.0030 0.0285 0.2865)
+(0.0060 0.0285 0.2865)
+(-0.0060 0.0315 0.2865)
+(-0.0030 0.0315 0.2865)
+(0.0000 0.0315 0.2865)
+(0.0030 0.0315 0.2865)
+(0.0060 0.0315 0.2865)
+(-0.0060 0.0345 0.2865)
+(-0.0030 0.0345 0.2865)
+(0.0000 0.0345 0.2865)
+(0.0030 0.0345 0.2865)
+(0.0060 0.0345 0.2865)
+(-0.0060 0.0375 0.2865)
+(-0.0030 0.0375 0.2865)
+(0.0000 0.0375 0.2865)
+(0.0030 0.0375 0.2865)
+(0.0060 0.0375 0.2865)
+(-0.0060 0.0405 0.2865)
+(-0.0030 0.0405 0.2865)
+(0.0000 0.0405 0.2865)
+(0.0030 0.0405 0.2865)
+(0.0060 0.0405 0.2865)
+(-0.0060 0.0435 0.2865)
+(-0.0030 0.0435 0.2865)
+(0.0000 0.0435 0.2865)
+(0.0030 0.0435 0.2865)
+(0.0060 0.0435 0.2865)
+(-0.0060 0.0465 0.2865)
+(-0.0030 0.0465 0.2865)
+(0.0000 0.0465 0.2865)
+(0.0030 0.0465 0.2865)
+(0.0060 0.0465 0.2865)
+(-0.0060 0.0495 0.2865)
+(-0.0030 0.0495 0.2865)
+(0.0000 0.0495 0.2865)
+(0.0030 0.0495 0.2865)
+(0.0060 0.0495 0.2865)
+(-0.0060 0.0525 0.2865)
+(-0.0030 0.0525 0.2865)
+(0.0000 0.0525 0.2865)
+(0.0030 0.0525 0.2865)
+(0.0060 0.0525 0.2865)
+(-0.0060 0.0555 0.2865)
+(-0.0030 0.0555 0.2865)
+(0.0000 0.0555 0.2865)
+(0.0030 0.0555 0.2865)
+(0.0060 0.0555 0.2865)
+(-0.0060 0.0585 0.2865)
+(-0.0030 0.0585 0.2865)
+(0.0000 0.0585 0.2865)
+(0.0030 0.0585 0.2865)
+(0.0060 0.0585 0.2865)
+(-0.0060 0.0615 0.2865)
+(-0.0030 0.0615 0.2865)
+(0.0000 0.0615 0.2865)
+(0.0030 0.0615 0.2865)
+(0.0060 0.0615 0.2865)
+(-0.0060 0.0645 0.2865)
+(-0.0030 0.0645 0.2865)
+(0.0000 0.0645 0.2865)
+(0.0030 0.0645 0.2865)
+(0.0060 0.0645 0.2865)
+(-0.0060 0.0675 0.2865)
+(-0.0030 0.0675 0.2865)
+(0.0000 0.0675 0.2865)
+(0.0030 0.0675 0.2865)
+(0.0060 0.0675 0.2865)
+(-0.0060 0.0705 0.2865)
+(-0.0030 0.0705 0.2865)
+(0.0000 0.0705 0.2865)
+(0.0030 0.0705 0.2865)
+(0.0060 0.0705 0.2865)
+(-0.0060 0.0735 0.2865)
+(-0.0030 0.0735 0.2865)
+(0.0000 0.0735 0.2865)
+(0.0030 0.0735 0.2865)
+(0.0060 0.0735 0.2865)
+(-0.0060 -0.0735 0.2895)
+(-0.0030 -0.0735 0.2895)
+(0.0000 -0.0735 0.2895)
+(0.0030 -0.0735 0.2895)
+(0.0060 -0.0735 0.2895)
+(-0.0060 -0.0705 0.2895)
+(-0.0030 -0.0705 0.2895)
+(0.0000 -0.0705 0.2895)
+(0.0030 -0.0705 0.2895)
+(0.0060 -0.0705 0.2895)
+(-0.0060 -0.0675 0.2895)
+(-0.0030 -0.0675 0.2895)
+(0.0000 -0.0675 0.2895)
+(0.0030 -0.0675 0.2895)
+(0.0060 -0.0675 0.2895)
+(-0.0060 -0.0645 0.2895)
+(-0.0030 -0.0645 0.2895)
+(0.0000 -0.0645 0.2895)
+(0.0030 -0.0645 0.2895)
+(0.0060 -0.0645 0.2895)
+(-0.0060 -0.0615 0.2895)
+(-0.0030 -0.0615 0.2895)
+(0.0000 -0.0615 0.2895)
+(0.0030 -0.0615 0.2895)
+(0.0060 -0.0615 0.2895)
+(-0.0060 -0.0585 0.2895)
+(-0.0030 -0.0585 0.2895)
+(0.0000 -0.0585 0.2895)
+(0.0030 -0.0585 0.2895)
+(0.0060 -0.0585 0.2895)
+(-0.0060 -0.0555 0.2895)
+(-0.0030 -0.0555 0.2895)
+(0.0000 -0.0555 0.2895)
+(0.0030 -0.0555 0.2895)
+(0.0060 -0.0555 0.2895)
+(-0.0060 -0.0525 0.2895)
+(-0.0030 -0.0525 0.2895)
+(0.0000 -0.0525 0.2895)
+(0.0030 -0.0525 0.2895)
+(0.0060 -0.0525 0.2895)
+(-0.0060 -0.0495 0.2895)
+(-0.0030 -0.0495 0.2895)
+(0.0000 -0.0495 0.2895)
+(0.0030 -0.0495 0.2895)
+(0.0060 -0.0495 0.2895)
+(-0.0060 -0.0465 0.2895)
+(-0.0030 -0.0465 0.2895)
+(0.0000 -0.0465 0.2895)
+(0.0030 -0.0465 0.2895)
+(0.0060 -0.0465 0.2895)
+(-0.0060 -0.0435 0.2895)
+(-0.0030 -0.0435 0.2895)
+(0.0000 -0.0435 0.2895)
+(0.0030 -0.0435 0.2895)
+(0.0060 -0.0435 0.2895)
+(-0.0060 -0.0405 0.2895)
+(-0.0030 -0.0405 0.2895)
+(0.0000 -0.0405 0.2895)
+(0.0030 -0.0405 0.2895)
+(0.0060 -0.0405 0.2895)
+(-0.0060 -0.0375 0.2895)
+(-0.0030 -0.0375 0.2895)
+(0.0000 -0.0375 0.2895)
+(0.0030 -0.0375 0.2895)
+(0.0060 -0.0375 0.2895)
+(-0.0060 -0.0345 0.2895)
+(-0.0030 -0.0345 0.2895)
+(0.0000 -0.0345 0.2895)
+(0.0030 -0.0345 0.2895)
+(0.0060 -0.0345 0.2895)
+(-0.0060 -0.0315 0.2895)
+(-0.0030 -0.0315 0.2895)
+(0.0000 -0.0315 0.2895)
+(0.0030 -0.0315 0.2895)
+(0.0060 -0.0315 0.2895)
+(-0.0060 -0.0285 0.2895)
+(-0.0030 -0.0285 0.2895)
+(0.0000 -0.0285 0.2895)
+(0.0030 -0.0285 0.2895)
+(0.0060 -0.0285 0.2895)
+(-0.0060 -0.0255 0.2895)
+(-0.0030 -0.0255 0.2895)
+(0.0000 -0.0255 0.2895)
+(0.0030 -0.0255 0.2895)
+(0.0060 -0.0255 0.2895)
+(-0.0060 -0.0225 0.2895)
+(-0.0030 -0.0225 0.2895)
+(0.0000 -0.0225 0.2895)
+(0.0030 -0.0225 0.2895)
+(0.0060 -0.0225 0.2895)
+(-0.0060 -0.0195 0.2895)
+(-0.0030 -0.0195 0.2895)
+(0.0000 -0.0195 0.2895)
+(0.0030 -0.0195 0.2895)
+(0.0060 -0.0195 0.2895)
+(-0.0060 -0.0165 0.2895)
+(-0.0030 -0.0165 0.2895)
+(0.0000 -0.0165 0.2895)
+(0.0030 -0.0165 0.2895)
+(0.0060 -0.0165 0.2895)
+(-0.0060 -0.0135 0.2895)
+(-0.0030 -0.0135 0.2895)
+(0.0000 -0.0135 0.2895)
+(0.0030 -0.0135 0.2895)
+(0.0060 -0.0135 0.2895)
+(-0.0060 -0.0105 0.2895)
+(-0.0030 -0.0105 0.2895)
+(0.0000 -0.0105 0.2895)
+(0.0030 -0.0105 0.2895)
+(0.0060 -0.0105 0.2895)
+(-0.0060 -0.0075 0.2895)
+(-0.0030 -0.0075 0.2895)
+(0.0000 -0.0075 0.2895)
+(0.0030 -0.0075 0.2895)
+(0.0060 -0.0075 0.2895)
+(-0.0060 -0.0045 0.2895)
+(-0.0030 -0.0045 0.2895)
+(0.0000 -0.0045 0.2895)
+(0.0030 -0.0045 0.2895)
+(0.0060 -0.0045 0.2895)
+(-0.0060 -0.0015 0.2895)
+(-0.0030 -0.0015 0.2895)
+(0.0000 -0.0015 0.2895)
+(0.0030 -0.0015 0.2895)
+(0.0060 -0.0015 0.2895)
+(-0.0060 0.0015 0.2895)
+(-0.0030 0.0015 0.2895)
+(0.0000 0.0015 0.2895)
+(0.0030 0.0015 0.2895)
+(0.0060 0.0015 0.2895)
+(-0.0060 0.0045 0.2895)
+(-0.0030 0.0045 0.2895)
+(0.0000 0.0045 0.2895)
+(0.0030 0.0045 0.2895)
+(0.0060 0.0045 0.2895)
+(-0.0060 0.0075 0.2895)
+(-0.0030 0.0075 0.2895)
+(0.0000 0.0075 0.2895)
+(0.0030 0.0075 0.2895)
+(0.0060 0.0075 0.2895)
+(-0.0060 0.0105 0.2895)
+(-0.0030 0.0105 0.2895)
+(0.0000 0.0105 0.2895)
+(0.0030 0.0105 0.2895)
+(0.0060 0.0105 0.2895)
+(-0.0060 0.0135 0.2895)
+(-0.0030 0.0135 0.2895)
+(0.0000 0.0135 0.2895)
+(0.0030 0.0135 0.2895)
+(0.0060 0.0135 0.2895)
+(-0.0060 0.0165 0.2895)
+(-0.0030 0.0165 0.2895)
+(0.0000 0.0165 0.2895)
+(0.0030 0.0165 0.2895)
+(0.0060 0.0165 0.2895)
+(-0.0060 0.0195 0.2895)
+(-0.0030 0.0195 0.2895)
+(0.0000 0.0195 0.2895)
+(0.0030 0.0195 0.2895)
+(0.0060 0.0195 0.2895)
+(-0.0060 0.0225 0.2895)
+(-0.0030 0.0225 0.2895)
+(0.0000 0.0225 0.2895)
+(0.0030 0.0225 0.2895)
+(0.0060 0.0225 0.2895)
+(-0.0060 0.0255 0.2895)
+(-0.0030 0.0255 0.2895)
+(0.0000 0.0255 0.2895)
+(0.0030 0.0255 0.2895)
+(0.0060 0.0255 0.2895)
+(-0.0060 0.0285 0.2895)
+(-0.0030 0.0285 0.2895)
+(0.0000 0.0285 0.2895)
+(0.0030 0.0285 0.2895)
+(0.0060 0.0285 0.2895)
+(-0.0060 0.0315 0.2895)
+(-0.0030 0.0315 0.2895)
+(0.0000 0.0315 0.2895)
+(0.0030 0.0315 0.2895)
+(0.0060 0.0315 0.2895)
+(-0.0060 0.0345 0.2895)
+(-0.0030 0.0345 0.2895)
+(0.0000 0.0345 0.2895)
+(0.0030 0.0345 0.2895)
+(0.0060 0.0345 0.2895)
+(-0.0060 0.0375 0.2895)
+(-0.0030 0.0375 0.2895)
+(0.0000 0.0375 0.2895)
+(0.0030 0.0375 0.2895)
+(0.0060 0.0375 0.2895)
+(-0.0060 0.0405 0.2895)
+(-0.0030 0.0405 0.2895)
+(0.0000 0.0405 0.2895)
+(0.0030 0.0405 0.2895)
+(0.0060 0.0405 0.2895)
+(-0.0060 0.0435 0.2895)
+(-0.0030 0.0435 0.2895)
+(0.0000 0.0435 0.2895)
+(0.0030 0.0435 0.2895)
+(0.0060 0.0435 0.2895)
+(-0.0060 0.0465 0.2895)
+(-0.0030 0.0465 0.2895)
+(0.0000 0.0465 0.2895)
+(0.0030 0.0465 0.2895)
+(0.0060 0.0465 0.2895)
+(-0.0060 0.0495 0.2895)
+(-0.0030 0.0495 0.2895)
+(0.0000 0.0495 0.2895)
+(0.0030 0.0495 0.2895)
+(0.0060 0.0495 0.2895)
+(-0.0060 0.0525 0.2895)
+(-0.0030 0.0525 0.2895)
+(0.0000 0.0525 0.2895)
+(0.0030 0.0525 0.2895)
+(0.0060 0.0525 0.2895)
+(-0.0060 0.0555 0.2895)
+(-0.0030 0.0555 0.2895)
+(0.0000 0.0555 0.2895)
+(0.0030 0.0555 0.2895)
+(0.0060 0.0555 0.2895)
+(-0.0060 0.0585 0.2895)
+(-0.0030 0.0585 0.2895)
+(0.0000 0.0585 0.2895)
+(0.0030 0.0585 0.2895)
+(0.0060 0.0585 0.2895)
+(-0.0060 0.0615 0.2895)
+(-0.0030 0.0615 0.2895)
+(0.0000 0.0615 0.2895)
+(0.0030 0.0615 0.2895)
+(0.0060 0.0615 0.2895)
+(-0.0060 0.0645 0.2895)
+(-0.0030 0.0645 0.2895)
+(0.0000 0.0645 0.2895)
+(0.0030 0.0645 0.2895)
+(0.0060 0.0645 0.2895)
+(-0.0060 0.0675 0.2895)
+(-0.0030 0.0675 0.2895)
+(0.0000 0.0675 0.2895)
+(0.0030 0.0675 0.2895)
+(0.0060 0.0675 0.2895)
+(-0.0060 0.0705 0.2895)
+(-0.0030 0.0705 0.2895)
+(0.0000 0.0705 0.2895)
+(0.0030 0.0705 0.2895)
+(0.0060 0.0705 0.2895)
+(-0.0060 0.0735 0.2895)
+(-0.0030 0.0735 0.2895)
+(0.0000 0.0735 0.2895)
+(0.0030 0.0735 0.2895)
+(0.0060 0.0735 0.2895)
+(-0.0060 -0.0735 0.2925)
+(-0.0030 -0.0735 0.2925)
+(0.0000 -0.0735 0.2925)
+(0.0030 -0.0735 0.2925)
+(0.0060 -0.0735 0.2925)
+(-0.0060 -0.0705 0.2925)
+(-0.0030 -0.0705 0.2925)
+(0.0000 -0.0705 0.2925)
+(0.0030 -0.0705 0.2925)
+(0.0060 -0.0705 0.2925)
+(-0.0060 -0.0675 0.2925)
+(-0.0030 -0.0675 0.2925)
+(0.0000 -0.0675 0.2925)
+(0.0030 -0.0675 0.2925)
+(0.0060 -0.0675 0.2925)
+(-0.0060 -0.0645 0.2925)
+(-0.0030 -0.0645 0.2925)
+(0.0000 -0.0645 0.2925)
+(0.0030 -0.0645 0.2925)
+(0.0060 -0.0645 0.2925)
+(-0.0060 -0.0615 0.2925)
+(-0.0030 -0.0615 0.2925)
+(0.0000 -0.0615 0.2925)
+(0.0030 -0.0615 0.2925)
+(0.0060 -0.0615 0.2925)
+(-0.0060 -0.0585 0.2925)
+(-0.0030 -0.0585 0.2925)
+(0.0000 -0.0585 0.2925)
+(0.0030 -0.0585 0.2925)
+(0.0060 -0.0585 0.2925)
+(-0.0060 -0.0555 0.2925)
+(-0.0030 -0.0555 0.2925)
+(0.0000 -0.0555 0.2925)
+(0.0030 -0.0555 0.2925)
+(0.0060 -0.0555 0.2925)
+(-0.0060 -0.0525 0.2925)
+(-0.0030 -0.0525 0.2925)
+(0.0000 -0.0525 0.2925)
+(0.0030 -0.0525 0.2925)
+(0.0060 -0.0525 0.2925)
+(-0.0060 -0.0495 0.2925)
+(-0.0030 -0.0495 0.2925)
+(0.0000 -0.0495 0.2925)
+(0.0030 -0.0495 0.2925)
+(0.0060 -0.0495 0.2925)
+(-0.0060 -0.0465 0.2925)
+(-0.0030 -0.0465 0.2925)
+(0.0000 -0.0465 0.2925)
+(0.0030 -0.0465 0.2925)
+(0.0060 -0.0465 0.2925)
+(-0.0060 -0.0435 0.2925)
+(-0.0030 -0.0435 0.2925)
+(0.0000 -0.0435 0.2925)
+(0.0030 -0.0435 0.2925)
+(0.0060 -0.0435 0.2925)
+(-0.0060 -0.0405 0.2925)
+(-0.0030 -0.0405 0.2925)
+(0.0000 -0.0405 0.2925)
+(0.0030 -0.0405 0.2925)
+(0.0060 -0.0405 0.2925)
+(-0.0060 -0.0375 0.2925)
+(-0.0030 -0.0375 0.2925)
+(0.0000 -0.0375 0.2925)
+(0.0030 -0.0375 0.2925)
+(0.0060 -0.0375 0.2925)
+(-0.0060 -0.0345 0.2925)
+(-0.0030 -0.0345 0.2925)
+(0.0000 -0.0345 0.2925)
+(0.0030 -0.0345 0.2925)
+(0.0060 -0.0345 0.2925)
+(-0.0060 -0.0315 0.2925)
+(-0.0030 -0.0315 0.2925)
+(0.0000 -0.0315 0.2925)
+(0.0030 -0.0315 0.2925)
+(0.0060 -0.0315 0.2925)
+(-0.0060 -0.0285 0.2925)
+(-0.0030 -0.0285 0.2925)
+(0.0000 -0.0285 0.2925)
+(0.0030 -0.0285 0.2925)
+(0.0060 -0.0285 0.2925)
+(-0.0060 -0.0255 0.2925)
+(-0.0030 -0.0255 0.2925)
+(0.0000 -0.0255 0.2925)
+(0.0030 -0.0255 0.2925)
+(0.0060 -0.0255 0.2925)
+(-0.0060 -0.0225 0.2925)
+(-0.0030 -0.0225 0.2925)
+(0.0000 -0.0225 0.2925)
+(0.0030 -0.0225 0.2925)
+(0.0060 -0.0225 0.2925)
+(-0.0060 -0.0195 0.2925)
+(-0.0030 -0.0195 0.2925)
+(0.0000 -0.0195 0.2925)
+(0.0030 -0.0195 0.2925)
+(0.0060 -0.0195 0.2925)
+(-0.0060 -0.0165 0.2925)
+(-0.0030 -0.0165 0.2925)
+(0.0000 -0.0165 0.2925)
+(0.0030 -0.0165 0.2925)
+(0.0060 -0.0165 0.2925)
+(-0.0060 -0.0135 0.2925)
+(-0.0030 -0.0135 0.2925)
+(0.0000 -0.0135 0.2925)
+(0.0030 -0.0135 0.2925)
+(0.0060 -0.0135 0.2925)
+(-0.0060 -0.0105 0.2925)
+(-0.0030 -0.0105 0.2925)
+(0.0000 -0.0105 0.2925)
+(0.0030 -0.0105 0.2925)
+(0.0060 -0.0105 0.2925)
+(-0.0060 -0.0075 0.2925)
+(-0.0030 -0.0075 0.2925)
+(0.0000 -0.0075 0.2925)
+(0.0030 -0.0075 0.2925)
+(0.0060 -0.0075 0.2925)
+(-0.0060 -0.0045 0.2925)
+(-0.0030 -0.0045 0.2925)
+(0.0000 -0.0045 0.2925)
+(0.0030 -0.0045 0.2925)
+(0.0060 -0.0045 0.2925)
+(-0.0060 -0.0015 0.2925)
+(-0.0030 -0.0015 0.2925)
+(0.0000 -0.0015 0.2925)
+(0.0030 -0.0015 0.2925)
+(0.0060 -0.0015 0.2925)
+(-0.0060 0.0015 0.2925)
+(-0.0030 0.0015 0.2925)
+(0.0000 0.0015 0.2925)
+(0.0030 0.0015 0.2925)
+(0.0060 0.0015 0.2925)
+(-0.0060 0.0045 0.2925)
+(-0.0030 0.0045 0.2925)
+(0.0000 0.0045 0.2925)
+(0.0030 0.0045 0.2925)
+(0.0060 0.0045 0.2925)
+(-0.0060 0.0075 0.2925)
+(-0.0030 0.0075 0.2925)
+(0.0000 0.0075 0.2925)
+(0.0030 0.0075 0.2925)
+(0.0060 0.0075 0.2925)
+(-0.0060 0.0105 0.2925)
+(-0.0030 0.0105 0.2925)
+(0.0000 0.0105 0.2925)
+(0.0030 0.0105 0.2925)
+(0.0060 0.0105 0.2925)
+(-0.0060 0.0135 0.2925)
+(-0.0030 0.0135 0.2925)
+(0.0000 0.0135 0.2925)
+(0.0030 0.0135 0.2925)
+(0.0060 0.0135 0.2925)
+(-0.0060 0.0165 0.2925)
+(-0.0030 0.0165 0.2925)
+(0.0000 0.0165 0.2925)
+(0.0030 0.0165 0.2925)
+(0.0060 0.0165 0.2925)
+(-0.0060 0.0195 0.2925)
+(-0.0030 0.0195 0.2925)
+(0.0000 0.0195 0.2925)
+(0.0030 0.0195 0.2925)
+(0.0060 0.0195 0.2925)
+(-0.0060 0.0225 0.2925)
+(-0.0030 0.0225 0.2925)
+(0.0000 0.0225 0.2925)
+(0.0030 0.0225 0.2925)
+(0.0060 0.0225 0.2925)
+(-0.0060 0.0255 0.2925)
+(-0.0030 0.0255 0.2925)
+(0.0000 0.0255 0.2925)
+(0.0030 0.0255 0.2925)
+(0.0060 0.0255 0.2925)
+(-0.0060 0.0285 0.2925)
+(-0.0030 0.0285 0.2925)
+(0.0000 0.0285 0.2925)
+(0.0030 0.0285 0.2925)
+(0.0060 0.0285 0.2925)
+(-0.0060 0.0315 0.2925)
+(-0.0030 0.0315 0.2925)
+(0.0000 0.0315 0.2925)
+(0.0030 0.0315 0.2925)
+(0.0060 0.0315 0.2925)
+(-0.0060 0.0345 0.2925)
+(-0.0030 0.0345 0.2925)
+(0.0000 0.0345 0.2925)
+(0.0030 0.0345 0.2925)
+(0.0060 0.0345 0.2925)
+(-0.0060 0.0375 0.2925)
+(-0.0030 0.0375 0.2925)
+(0.0000 0.0375 0.2925)
+(0.0030 0.0375 0.2925)
+(0.0060 0.0375 0.2925)
+(-0.0060 0.0405 0.2925)
+(-0.0030 0.0405 0.2925)
+(0.0000 0.0405 0.2925)
+(0.0030 0.0405 0.2925)
+(0.0060 0.0405 0.2925)
+(-0.0060 0.0435 0.2925)
+(-0.0030 0.0435 0.2925)
+(0.0000 0.0435 0.2925)
+(0.0030 0.0435 0.2925)
+(0.0060 0.0435 0.2925)
+(-0.0060 0.0465 0.2925)
+(-0.0030 0.0465 0.2925)
+(0.0000 0.0465 0.2925)
+(0.0030 0.0465 0.2925)
+(0.0060 0.0465 0.2925)
+(-0.0060 0.0495 0.2925)
+(-0.0030 0.0495 0.2925)
+(0.0000 0.0495 0.2925)
+(0.0030 0.0495 0.2925)
+(0.0060 0.0495 0.2925)
+(-0.0060 0.0525 0.2925)
+(-0.0030 0.0525 0.2925)
+(0.0000 0.0525 0.2925)
+(0.0030 0.0525 0.2925)
+(0.0060 0.0525 0.2925)
+(-0.0060 0.0555 0.2925)
+(-0.0030 0.0555 0.2925)
+(0.0000 0.0555 0.2925)
+(0.0030 0.0555 0.2925)
+(0.0060 0.0555 0.2925)
+(-0.0060 0.0585 0.2925)
+(-0.0030 0.0585 0.2925)
+(0.0000 0.0585 0.2925)
+(0.0030 0.0585 0.2925)
+(0.0060 0.0585 0.2925)
+(-0.0060 0.0615 0.2925)
+(-0.0030 0.0615 0.2925)
+(0.0000 0.0615 0.2925)
+(0.0030 0.0615 0.2925)
+(0.0060 0.0615 0.2925)
+(-0.0060 0.0645 0.2925)
+(-0.0030 0.0645 0.2925)
+(0.0000 0.0645 0.2925)
+(0.0030 0.0645 0.2925)
+(0.0060 0.0645 0.2925)
+(-0.0060 0.0675 0.2925)
+(-0.0030 0.0675 0.2925)
+(0.0000 0.0675 0.2925)
+(0.0030 0.0675 0.2925)
+(0.0060 0.0675 0.2925)
+(-0.0060 0.0705 0.2925)
+(-0.0030 0.0705 0.2925)
+(0.0000 0.0705 0.2925)
+(0.0030 0.0705 0.2925)
+(0.0060 0.0705 0.2925)
+(-0.0060 0.0735 0.2925)
+(-0.0030 0.0735 0.2925)
+(0.0000 0.0735 0.2925)
+(0.0030 0.0735 0.2925)
+(0.0060 0.0735 0.2925)
+(-0.0060 -0.0735 0.2955)
+(-0.0030 -0.0735 0.2955)
+(0.0000 -0.0735 0.2955)
+(0.0030 -0.0735 0.2955)
+(0.0060 -0.0735 0.2955)
+(-0.0060 -0.0705 0.2955)
+(-0.0030 -0.0705 0.2955)
+(0.0000 -0.0705 0.2955)
+(0.0030 -0.0705 0.2955)
+(0.0060 -0.0705 0.2955)
+(-0.0060 -0.0675 0.2955)
+(-0.0030 -0.0675 0.2955)
+(0.0000 -0.0675 0.2955)
+(0.0030 -0.0675 0.2955)
+(0.0060 -0.0675 0.2955)
+(-0.0060 -0.0645 0.2955)
+(-0.0030 -0.0645 0.2955)
+(0.0000 -0.0645 0.2955)
+(0.0030 -0.0645 0.2955)
+(0.0060 -0.0645 0.2955)
+(-0.0060 -0.0615 0.2955)
+(-0.0030 -0.0615 0.2955)
+(0.0000 -0.0615 0.2955)
+(0.0030 -0.0615 0.2955)
+(0.0060 -0.0615 0.2955)
+(-0.0060 -0.0585 0.2955)
+(-0.0030 -0.0585 0.2955)
+(0.0000 -0.0585 0.2955)
+(0.0030 -0.0585 0.2955)
+(0.0060 -0.0585 0.2955)
+(-0.0060 -0.0555 0.2955)
+(-0.0030 -0.0555 0.2955)
+(0.0000 -0.0555 0.2955)
+(0.0030 -0.0555 0.2955)
+(0.0060 -0.0555 0.2955)
+(-0.0060 -0.0525 0.2955)
+(-0.0030 -0.0525 0.2955)
+(0.0000 -0.0525 0.2955)
+(0.0030 -0.0525 0.2955)
+(0.0060 -0.0525 0.2955)
+(-0.0060 -0.0495 0.2955)
+(-0.0030 -0.0495 0.2955)
+(0.0000 -0.0495 0.2955)
+(0.0030 -0.0495 0.2955)
+(0.0060 -0.0495 0.2955)
+(-0.0060 -0.0465 0.2955)
+(-0.0030 -0.0465 0.2955)
+(0.0000 -0.0465 0.2955)
+(0.0030 -0.0465 0.2955)
+(0.0060 -0.0465 0.2955)
+(-0.0060 -0.0435 0.2955)
+(-0.0030 -0.0435 0.2955)
+(0.0000 -0.0435 0.2955)
+(0.0030 -0.0435 0.2955)
+(0.0060 -0.0435 0.2955)
+(-0.0060 -0.0405 0.2955)
+(-0.0030 -0.0405 0.2955)
+(0.0000 -0.0405 0.2955)
+(0.0030 -0.0405 0.2955)
+(0.0060 -0.0405 0.2955)
+(-0.0060 -0.0375 0.2955)
+(-0.0030 -0.0375 0.2955)
+(0.0000 -0.0375 0.2955)
+(0.0030 -0.0375 0.2955)
+(0.0060 -0.0375 0.2955)
+(-0.0060 -0.0345 0.2955)
+(-0.0030 -0.0345 0.2955)
+(0.0000 -0.0345 0.2955)
+(0.0030 -0.0345 0.2955)
+(0.0060 -0.0345 0.2955)
+(-0.0060 -0.0315 0.2955)
+(-0.0030 -0.0315 0.2955)
+(0.0000 -0.0315 0.2955)
+(0.0030 -0.0315 0.2955)
+(0.0060 -0.0315 0.2955)
+(-0.0060 -0.0285 0.2955)
+(-0.0030 -0.0285 0.2955)
+(0.0000 -0.0285 0.2955)
+(0.0030 -0.0285 0.2955)
+(0.0060 -0.0285 0.2955)
+(-0.0060 -0.0255 0.2955)
+(-0.0030 -0.0255 0.2955)
+(0.0000 -0.0255 0.2955)
+(0.0030 -0.0255 0.2955)
+(0.0060 -0.0255 0.2955)
+(-0.0060 -0.0225 0.2955)
+(-0.0030 -0.0225 0.2955)
+(0.0000 -0.0225 0.2955)
+(0.0030 -0.0225 0.2955)
+(0.0060 -0.0225 0.2955)
+(-0.0060 -0.0195 0.2955)
+(-0.0030 -0.0195 0.2955)
+(0.0000 -0.0195 0.2955)
+(0.0030 -0.0195 0.2955)
+(0.0060 -0.0195 0.2955)
+(-0.0060 -0.0165 0.2955)
+(-0.0030 -0.0165 0.2955)
+(0.0000 -0.0165 0.2955)
+(0.0030 -0.0165 0.2955)
+(0.0060 -0.0165 0.2955)
+(-0.0060 -0.0135 0.2955)
+(-0.0030 -0.0135 0.2955)
+(0.0000 -0.0135 0.2955)
+(0.0030 -0.0135 0.2955)
+(0.0060 -0.0135 0.2955)
+(-0.0060 -0.0105 0.2955)
+(-0.0030 -0.0105 0.2955)
+(0.0000 -0.0105 0.2955)
+(0.0030 -0.0105 0.2955)
+(0.0060 -0.0105 0.2955)
+(-0.0060 -0.0075 0.2955)
+(-0.0030 -0.0075 0.2955)
+(0.0000 -0.0075 0.2955)
+(0.0030 -0.0075 0.2955)
+(0.0060 -0.0075 0.2955)
+(-0.0060 -0.0045 0.2955)
+(-0.0030 -0.0045 0.2955)
+(0.0000 -0.0045 0.2955)
+(0.0030 -0.0045 0.2955)
+(0.0060 -0.0045 0.2955)
+(-0.0060 -0.0015 0.2955)
+(-0.0030 -0.0015 0.2955)
+(0.0000 -0.0015 0.2955)
+(0.0030 -0.0015 0.2955)
+(0.0060 -0.0015 0.2955)
+(-0.0060 0.0015 0.2955)
+(-0.0030 0.0015 0.2955)
+(0.0000 0.0015 0.2955)
+(0.0030 0.0015 0.2955)
+(0.0060 0.0015 0.2955)
+(-0.0060 0.0045 0.2955)
+(-0.0030 0.0045 0.2955)
+(0.0000 0.0045 0.2955)
+(0.0030 0.0045 0.2955)
+(0.0060 0.0045 0.2955)
+(-0.0060 0.0075 0.2955)
+(-0.0030 0.0075 0.2955)
+(0.0000 0.0075 0.2955)
+(0.0030 0.0075 0.2955)
+(0.0060 0.0075 0.2955)
+(-0.0060 0.0105 0.2955)
+(-0.0030 0.0105 0.2955)
+(0.0000 0.0105 0.2955)
+(0.0030 0.0105 0.2955)
+(0.0060 0.0105 0.2955)
+(-0.0060 0.0135 0.2955)
+(-0.0030 0.0135 0.2955)
+(0.0000 0.0135 0.2955)
+(0.0030 0.0135 0.2955)
+(0.0060 0.0135 0.2955)
+(-0.0060 0.0165 0.2955)
+(-0.0030 0.0165 0.2955)
+(0.0000 0.0165 0.2955)
+(0.0030 0.0165 0.2955)
+(0.0060 0.0165 0.2955)
+(-0.0060 0.0195 0.2955)
+(-0.0030 0.0195 0.2955)
+(0.0000 0.0195 0.2955)
+(0.0030 0.0195 0.2955)
+(0.0060 0.0195 0.2955)
+(-0.0060 0.0225 0.2955)
+(-0.0030 0.0225 0.2955)
+(0.0000 0.0225 0.2955)
+(0.0030 0.0225 0.2955)
+(0.0060 0.0225 0.2955)
+(-0.0060 0.0255 0.2955)
+(-0.0030 0.0255 0.2955)
+(0.0000 0.0255 0.2955)
+(0.0030 0.0255 0.2955)
+(0.0060 0.0255 0.2955)
+(-0.0060 0.0285 0.2955)
+(-0.0030 0.0285 0.2955)
+(0.0000 0.0285 0.2955)
+(0.0030 0.0285 0.2955)
+(0.0060 0.0285 0.2955)
+(-0.0060 0.0315 0.2955)
+(-0.0030 0.0315 0.2955)
+(0.0000 0.0315 0.2955)
+(0.0030 0.0315 0.2955)
+(0.0060 0.0315 0.2955)
+(-0.0060 0.0345 0.2955)
+(-0.0030 0.0345 0.2955)
+(0.0000 0.0345 0.2955)
+(0.0030 0.0345 0.2955)
+(0.0060 0.0345 0.2955)
+(-0.0060 0.0375 0.2955)
+(-0.0030 0.0375 0.2955)
+(0.0000 0.0375 0.2955)
+(0.0030 0.0375 0.2955)
+(0.0060 0.0375 0.2955)
+(-0.0060 0.0405 0.2955)
+(-0.0030 0.0405 0.2955)
+(0.0000 0.0405 0.2955)
+(0.0030 0.0405 0.2955)
+(0.0060 0.0405 0.2955)
+(-0.0060 0.0435 0.2955)
+(-0.0030 0.0435 0.2955)
+(0.0000 0.0435 0.2955)
+(0.0030 0.0435 0.2955)
+(0.0060 0.0435 0.2955)
+(-0.0060 0.0465 0.2955)
+(-0.0030 0.0465 0.2955)
+(0.0000 0.0465 0.2955)
+(0.0030 0.0465 0.2955)
+(0.0060 0.0465 0.2955)
+(-0.0060 0.0495 0.2955)
+(-0.0030 0.0495 0.2955)
+(0.0000 0.0495 0.2955)
+(0.0030 0.0495 0.2955)
+(0.0060 0.0495 0.2955)
+(-0.0060 0.0525 0.2955)
+(-0.0030 0.0525 0.2955)
+(0.0000 0.0525 0.2955)
+(0.0030 0.0525 0.2955)
+(0.0060 0.0525 0.2955)
+(-0.0060 0.0555 0.2955)
+(-0.0030 0.0555 0.2955)
+(0.0000 0.0555 0.2955)
+(0.0030 0.0555 0.2955)
+(0.0060 0.0555 0.2955)
+(-0.0060 0.0585 0.2955)
+(-0.0030 0.0585 0.2955)
+(0.0000 0.0585 0.2955)
+(0.0030 0.0585 0.2955)
+(0.0060 0.0585 0.2955)
+(-0.0060 0.0615 0.2955)
+(-0.0030 0.0615 0.2955)
+(0.0000 0.0615 0.2955)
+(0.0030 0.0615 0.2955)
+(0.0060 0.0615 0.2955)
+(-0.0060 0.0645 0.2955)
+(-0.0030 0.0645 0.2955)
+(0.0000 0.0645 0.2955)
+(0.0030 0.0645 0.2955)
+(0.0060 0.0645 0.2955)
+(-0.0060 0.0675 0.2955)
+(-0.0030 0.0675 0.2955)
+(0.0000 0.0675 0.2955)
+(0.0030 0.0675 0.2955)
+(0.0060 0.0675 0.2955)
+(-0.0060 0.0705 0.2955)
+(-0.0030 0.0705 0.2955)
+(0.0000 0.0705 0.2955)
+(0.0030 0.0705 0.2955)
+(0.0060 0.0705 0.2955)
+(-0.0060 0.0735 0.2955)
+(-0.0030 0.0735 0.2955)
+(0.0000 0.0735 0.2955)
+(0.0030 0.0735 0.2955)
+(0.0060 0.0735 0.2955)
+)
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/kinematicCloudProperties b/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/kinematicCloudProperties
new file mode 100644
index 0000000000000000000000000000000000000000..fdb104bc2d338ac0908c4493ffc1c35c8666e0f6
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/kinematicCloudProperties
@@ -0,0 +1,196 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      particleProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+solution
+{
+    active          true;
+    coupled         true;
+    transient       yes;
+    cellValueSourceCorrection off;
+
+    maxCo           1.0;
+
+    interpolationSchemes
+    {
+        rho.air         cell;
+        U.air           cellPoint;
+        mu.air          cell;
+    }
+
+    averagingMethod dual;
+
+    integrationSchemes
+    {
+        U               Euler;
+    }
+
+    sourceTerms
+    {
+        schemes
+        {
+            U           semiImplicit 1;
+        }
+    }
+}
+
+constantProperties
+{
+    rho0            2526;
+    alphaMax        0.9;
+}
+
+subModels
+{
+    particleForces
+    {
+        PlessisMasliyahDrag
+        {
+            alphac alpha.air;
+        }
+        gravity;
+    }
+
+    injectionModels
+    {
+        model1
+        {
+            type            manualInjection;
+            massTotal       0;
+            parcelBasisType fixed;
+            nParticle       1;
+            SOI             0;
+            positionsFile   "kinematicCloudPositions";
+            U0              (0 0 0);
+            sizeDistribution
+            {
+                type        fixedValue;
+                fixedValueDistribution
+                {
+                    value   0.0025;
+                }
+            }
+        }
+    }
+
+    dispersionModel none;
+
+    patchInteractionModel localInteraction;
+
+    localInteractionCoeffs
+    {
+        patches
+        (
+            top
+            {
+                type rebound;
+                e    0.97;
+                mu   0.09;
+            }
+            bottom
+            {
+                type rebound;
+                e    0.97;
+                mu   0.09;
+            }
+            walls
+            {
+                type rebound;
+                e    0.97;
+                mu   0.09;
+            }
+            frontAndBack
+            {
+                type rebound;
+                e    0.97;
+                mu   0.09;
+            }
+        );
+    }
+
+    heatTransferModel none;
+
+    surfaceFilmModel none;
+
+    packingModel explicit;
+
+    explicitCoeffs
+    {
+        particleStressModel
+        {
+            type HarrisCrighton;
+            alphaPacked 0.65;
+            pSolid 10.0;
+            beta 2.0;
+            eps 1.0e-7;
+        }
+        correctionLimitingMethod
+        {
+            type absolute;
+            e 0.9;
+        }
+    }
+
+    implicitCoeffs
+    {
+        alphaMin 0.0001;
+        rhoMin 1.0;
+        applyGravity false;
+        particleStressModel
+        {
+            type HarrisCrighton;
+            alphaPacked 0.65;
+            pSolid 5.0;
+            beta 2.0;
+            eps 1.0e-2;
+        }
+    }
+
+    dampingModel none; //relaxation;
+
+    relaxationCoeffs
+    {
+        timeScaleModel
+        {
+            type nonEquilibrium;
+            alphaPacked 0.65;
+            e 0.9;
+        }
+    }
+
+    isotropyModel stochastic;
+
+    stochasticCoeffs
+    {
+        timeScaleModel
+        {
+            type isotropic;
+            alphaPacked 0.65;
+            e 0.9;
+        }
+    }
+
+    stochasticCollisionModel none;
+
+    radiation off;
+}
+
+
+cloudFunctions
+{}
+
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/polyMesh/blockMeshDict b/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/polyMesh/blockMeshDict
new file mode 100644
index 0000000000000000000000000000000000000000..34274f8b4ae8e9a824276661b49484e760a2d221
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/polyMesh/blockMeshDict
@@ -0,0 +1,81 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    object      blockMeshDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+convertToMeters 0.001;
+
+vertices
+(
+    (-7.5 -75   0)
+    ( 7.5 -75   0)
+    ( 7.5  75   0)
+    (-7.5  75   0)
+    (-7.5 -75 450)
+    ( 7.5 -75 450)
+    ( 7.5  75 450)
+    (-7.5  75 450)
+);
+
+blocks
+(
+    hex (0 1 2 3 4 5 6 7) (1 15 45) simpleGrading (1 1 1)
+);
+
+edges
+(
+);
+
+boundary
+(
+    top
+    {
+        type patch;
+        faces
+        (
+            (4 5 6 7)
+        );
+    }
+
+    bottom
+    {
+        type patch;
+        faces
+        (
+            (0 1 2 3)
+        );
+    }
+
+    walls
+    {
+        type wall;
+        faces
+        (
+            (0 1 5 4)
+            (2 3 7 6)
+        );
+    }
+
+    frontAndBack
+    {
+        type symmetry;
+        faces
+        (
+            (1 2 6 5)
+            (3 0 4 7)
+        );
+    }
+);
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/transportProperties b/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/transportProperties
new file mode 100644
index 0000000000000000000000000000000000000000..4a765004b6893f1251ebc17720869b1e7183b622
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/transportProperties
@@ -0,0 +1,25 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      transportProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+contiuousPhaseName air;
+
+rho.air         1.2;
+
+transportModel  Newtonian;
+nu              1.568e-05;
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/turbulenceProperties.air b/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/turbulenceProperties.air
new file mode 100644
index 0000000000000000000000000000000000000000..1296429b72a21953def920b08774aa75e1d048b1
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/Goldschmidt/constant/turbulenceProperties.air
@@ -0,0 +1,20 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      turbulenceProperties.air;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+simulationType  laminar;
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/Goldschmidt/system/controlDict b/tutorials/lagrangian/MPPICFoam/Goldschmidt/system/controlDict
new file mode 100644
index 0000000000000000000000000000000000000000..808ac7e71c458085b08ceb03ade063f0a06ff91f
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/Goldschmidt/system/controlDict
@@ -0,0 +1,48 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "system";
+    object      controlDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+application     MPPICFoam;
+
+startFrom       startTime;
+
+startTime       0;
+
+stopAt          endTime;
+
+endTime         10;
+
+deltaT          2e-4;
+
+writeControl    runTime;
+
+writeInterval   0.01;
+
+purgeWrite      0;
+
+writeFormat     ascii;
+
+writePrecision  6;
+
+writeCompression uncompressed;
+
+timeFormat      general;
+
+timePrecision   6;
+
+runTimeModifiable yes;
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/Goldschmidt/system/decomposeParDict b/tutorials/lagrangian/MPPICFoam/Goldschmidt/system/decomposeParDict
new file mode 100644
index 0000000000000000000000000000000000000000..ab628fb24fe22316059712d1bfd4badbc66c0a32
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/Goldschmidt/system/decomposeParDict
@@ -0,0 +1,28 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "system";
+    object      decomposeParDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+numberOfSubdomains 5;
+
+method          simple;
+
+simpleCoeffs
+{
+    n               ( 1 5 1 );
+    delta           0.001;
+}
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/Goldschmidt/system/fvSchemes b/tutorials/lagrangian/MPPICFoam/Goldschmidt/system/fvSchemes
new file mode 100644
index 0000000000000000000000000000000000000000..9d861df1b9be424b3d21500e9c0db5b8c3226a12
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/Goldschmidt/system/fvSchemes
@@ -0,0 +1,59 @@
+/*--------------------------------*- 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      fvSchemes;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+ddtSchemes
+{
+    default Euler;
+}
+
+gradSchemes
+{
+    default         Gauss linear;
+}
+
+divSchemes
+{
+    default         none;
+
+    div(alphaPhic,U.air)    Gauss linearUpwindV unlimited;
+    div(((alpha.air*nuEff)*dev2(T(grad(U.air))))) Gauss linear;
+
+    div(phiGByA,kinematicCloud:alpha) Gauss linear;
+}
+
+laplacianSchemes
+{
+    default         Gauss linear corrected;
+}
+
+interpolationSchemes
+{
+    default         linear;
+}
+
+snGradSchemes
+{
+    default         corrected;
+}
+
+fluxRequired
+{
+    default         no;
+    p;
+    kinematicCloud:alpha;
+}
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/Goldschmidt/system/fvSolution b/tutorials/lagrangian/MPPICFoam/Goldschmidt/system/fvSolution
new file mode 100644
index 0000000000000000000000000000000000000000..e1353a6e33de46298d1a7574255205d024cc346b
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/Goldschmidt/system/fvSolution
@@ -0,0 +1,84 @@
+/*--------------------------------*- 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          GAMG;
+        tolerance       1e-06;
+        relTol          0.01;
+        smoother        GaussSeidel;
+        cacheAgglomeration true;
+        nCellsInCoarsestLevel 10;
+        agglomerator    faceAreaPair;
+        mergeLevels     1;
+    }
+
+    pFinal
+    {
+        solver          GAMG;
+        tolerance       1e-06;
+        relTol          0;
+        smoother        GaussSeidel;
+        cacheAgglomeration true;
+        nCellsInCoarsestLevel 10;
+        agglomerator    faceAreaPair;
+        mergeLevels     1;
+    }
+
+    "(U.air|k|omega)"
+    {
+        solver          PBiCG;
+        preconditioner  DILU;
+        tolerance       1e-05;
+        relTol          0.1;
+    }
+
+    "(U.air|k|omega)Final"
+    {
+        solver          PBiCG;
+        preconditioner  DILU;
+        tolerance       1e-05;
+        relTol          0;
+    }
+
+    kinematicCloud:alpha
+    {
+        solver          PCG; //PBiCG;
+        preconditioner  DIC; //DILU;
+        tolerance       1e-06;
+        relTol          0;
+    }
+}
+
+PIMPLE
+{
+    nOuterCorrectors 1;
+    nCorrectors     2;
+    momentumPredictor yes;
+    nNonOrthogonalCorrectors 0;
+    pRefCell        0;
+    pRefValue       0;
+}
+
+relaxationFactors
+{
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/column/0/U.air b/tutorials/lagrangian/MPPICFoam/column/0/U.air
new file mode 100644
index 0000000000000000000000000000000000000000..fefe194de0ab13d710931c6e763031a8677f554a
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/column/0/U.air
@@ -0,0 +1,42 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      binary;
+    class       volVectorField;
+    location    "0";
+    object      U;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 1 -1 0 0 0 0];
+
+internalField   uniform (0 0 0);
+
+boundaryField
+{
+    sides
+    {
+        type            symmetry;
+    }
+
+    top
+    {
+        type            fixedValue;
+        value           uniform (0 0 0);
+    }
+
+    bottom
+    {
+        type            fixedValue;
+        value           uniform (0 0 0);
+    }
+}
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/column/0/p b/tutorials/lagrangian/MPPICFoam/column/0/p
new file mode 100644
index 0000000000000000000000000000000000000000..072964ff05d49541cde399c4ef3b55d51341e7af
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/column/0/p
@@ -0,0 +1,43 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       volScalarField;
+    object      p;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 2 -2 0 0 0 0];
+
+internalField   uniform 0;
+
+boundaryField
+{
+    sides
+    {
+        type            symmetry;
+    }
+
+    top
+    {
+        type            fixedFluxPressure;
+        phi             phi.air;
+        value           $internalField;
+    }
+
+    bottom
+    {
+        type            fixedFluxPressure;
+        phi             phi.air;
+        value           $internalField;
+    }
+}
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/column/constant/RASProperties b/tutorials/lagrangian/MPPICFoam/column/constant/RASProperties
new file mode 100644
index 0000000000000000000000000000000000000000..cc1647b252d10958360b5bd52d0d74cac11b73c2
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/column/constant/RASProperties
@@ -0,0 +1,25 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      RASProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+RASModel        laminar;
+
+turbulence      on;
+
+printCoeffs     on;
+
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/column/constant/g b/tutorials/lagrangian/MPPICFoam/column/constant/g
new file mode 100644
index 0000000000000000000000000000000000000000..897615a50df92736e7b9c64bb2e64fba539496fc
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/column/constant/g
@@ -0,0 +1,22 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       uniformDimensionedVectorField;
+    location    "constant";
+    object      g;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 1 -2 0 0 0 0];
+value           ( 0 0 -9.81 );
+
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/column/constant/kinematicCloudPositions b/tutorials/lagrangian/MPPICFoam/column/constant/kinematicCloudPositions
new file mode 100644
index 0000000000000000000000000000000000000000..000c72a9448485efcc18af66401bea0bacc0a2c2
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/column/constant/kinematicCloudPositions
@@ -0,0 +1,2893 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       vectorField;
+    object      kinematicCloudPositions;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+(
+(-0.007603 -0.000496 0.186242)
+(0.005296 0.002961 0.249746)
+(-0.003631 0.006625 0.222195)
+(0.003463 0.007655 0.252834)
+(-0.000193 -0.005658 0.248415)
+(-0.003550 0.002809 0.174872)
+(0.009027 0.008018 0.046837)
+(-0.004634 -0.007571 0.253276)
+(-0.007939 0.007436 0.149918)
+(0.006590 0.006213 0.222370)
+(-0.006731 -0.000662 0.165514)
+(-0.008975 -0.006064 0.057685)
+(0.004256 -0.008315 0.021390)
+(-0.006722 0.006600 0.283040)
+(-0.007295 0.000892 0.071601)
+(-0.002414 -0.000567 0.009041)
+(0.006973 0.006156 0.063900)
+(0.006231 0.007762 0.044097)
+(0.005540 0.005797 0.209102)
+(0.002454 0.001138 0.146698)
+(-0.007521 0.007371 0.009158)
+(-0.004755 -0.004976 0.014585)
+(-0.007842 0.006545 0.052000)
+(0.005661 0.006317 0.003238)
+(0.003626 0.001812 0.291785)
+(0.008115 -0.007354 0.204002)
+(0.002115 0.006613 0.240605)
+(-0.000511 0.006445 0.254471)
+(0.007178 -0.004356 0.274487)
+(-0.008346 0.003370 0.299902)
+(0.008936 0.000163 0.031491)
+(-0.000712 -0.005933 0.175032)
+(-0.000043 0.007958 0.053348)
+(-0.001838 0.005946 0.206753)
+(0.005476 -0.003146 0.013053)
+(0.007495 0.003946 0.077224)
+(0.005286 0.007725 0.021804)
+(-0.004363 0.006779 0.118588)
+(0.002750 0.007193 0.064800)
+(0.007731 0.003853 0.157675)
+(-0.005032 -0.006406 0.273652)
+(-0.004435 0.005790 0.008037)
+(0.003889 0.005180 0.140469)
+(0.000349 -0.003737 0.019915)
+(0.006767 0.005217 0.001389)
+(-0.001437 0.007885 0.001659)
+(0.004885 0.000983 0.039324)
+(0.007492 -0.004747 0.216493)
+(-0.003164 0.001354 0.113280)
+(0.007488 0.008913 0.208388)
+(0.006644 -0.001038 0.262499)
+(0.001757 -0.008763 0.183613)
+(-0.005182 0.008530 0.217370)
+(-0.002919 -0.003235 0.137830)
+(-0.003657 -0.004763 0.105567)
+(-0.000395 0.008680 0.107329)
+(0.003865 -0.001219 0.204188)
+(0.003060 0.006020 0.120016)
+(0.003798 0.007917 0.169609)
+(0.005715 -0.001379 0.241563)
+(-0.002788 0.006584 0.065112)
+(0.003801 0.007753 0.140773)
+(0.000357 -0.004884 0.248645)
+(-0.007648 0.003336 0.170331)
+(-0.001215 -0.006612 0.062768)
+(-0.001702 0.001762 0.276526)
+(-0.002756 -0.008567 0.180954)
+(0.004651 0.007550 0.078562)
+(-0.007210 0.001308 0.219866)
+(-0.007978 0.000766 0.105603)
+(-0.004335 -0.004064 0.148935)
+(-0.003113 0.002860 0.052422)
+(0.000491 0.008725 0.020609)
+(-0.007964 -0.000847 0.083414)
+(-0.003764 0.008425 0.078343)
+(-0.001991 0.001324 0.183160)
+(-0.006127 0.004721 0.220177)
+(-0.008995 -0.001952 0.241865)
+(0.001529 -0.003015 0.005323)
+(-0.003013 -0.006966 0.037501)
+(-0.006081 0.000230 0.029188)
+(-0.000596 0.003942 0.073891)
+(-0.000807 -0.003579 0.004964)
+(-0.001712 -0.001016 0.011441)
+(-0.007438 0.006134 0.162856)
+(-0.005150 -0.001534 0.160114)
+(-0.006203 0.002055 0.041237)
+(0.000651 -0.007232 0.092247)
+(-0.001916 -0.000603 0.030022)
+(0.004566 0.002462 0.070144)
+(-0.007156 0.004003 0.277508)
+(-0.008650 -0.001542 0.037296)
+(-0.007581 0.005454 0.094709)
+(0.005570 0.004826 0.096120)
+(-0.004889 0.000250 0.286516)
+(-0.002246 -0.000626 0.281994)
+(-0.005707 -0.005777 0.176166)
+(-0.005464 0.003902 0.118605)
+(0.000622 -0.004811 0.126102)
+(-0.007530 0.006553 0.066062)
+(0.002534 0.001785 0.099779)
+(-0.002617 0.003680 0.175780)
+(-0.005968 -0.002552 0.249858)
+(0.006410 -0.004529 0.059153)
+(-0.004893 0.005682 0.196030)
+(0.008919 -0.006259 0.194256)
+(0.003321 0.002499 0.094215)
+(-0.004268 0.003281 0.227810)
+(0.007704 -0.007761 0.296289)
+(-0.006205 -0.007076 0.084507)
+(0.004192 0.007977 0.264713)
+(0.000376 0.004661 0.174366)
+(0.002564 -0.003005 0.151533)
+(0.004754 0.000492 0.142922)
+(0.007431 0.003388 0.050819)
+(-0.003880 0.004680 0.222662)
+(-0.001443 -0.003874 0.091636)
+(0.008633 -0.001677 0.096070)
+(0.004056 -0.005587 0.184848)
+(0.006049 0.000301 0.036035)
+(0.003572 -0.002294 0.278810)
+(-0.000320 0.006516 0.190664)
+(-0.004717 0.000846 0.259795)
+(0.005079 0.005766 0.094034)
+(0.007055 -0.002091 0.150629)
+(-0.004568 -0.001220 0.244729)
+(-0.007494 -0.004358 0.090059)
+(-0.007521 -0.004612 0.280762)
+(0.002626 -0.005462 0.086975)
+(-0.001346 -0.006456 0.285513)
+(0.003525 -0.008089 0.125590)
+(0.000358 0.002639 0.286511)
+(0.000043 -0.005369 0.042436)
+(0.006821 -0.002250 0.221078)
+(0.002971 -0.006829 0.175609)
+(0.005572 -0.001736 0.065781)
+(-0.001033 -0.004852 0.076080)
+(-0.003897 -0.008214 0.201234)
+(0.006790 -0.007501 0.023214)
+(0.002794 0.007390 0.149217)
+(-0.007600 0.008359 0.047332)
+(-0.009171 0.002081 0.175130)
+(0.003707 -0.004297 0.081697)
+(-0.002253 0.007408 0.288633)
+(-0.003521 -0.001626 0.146564)
+(0.008478 0.002226 0.157429)
+(0.004217 0.008771 0.295844)
+(0.005893 -0.008935 0.098997)
+(0.001892 -0.001807 0.047893)
+(-0.001298 -0.005969 0.283680)
+(0.007287 0.008985 0.192547)
+(0.006137 -0.001888 0.257374)
+(0.007998 0.003982 0.042169)
+(0.003944 -0.002649 0.130659)
+(-0.006281 0.001943 0.187836)
+(-0.003270 -0.001103 0.072314)
+(0.003407 0.007087 0.166511)
+(-0.000278 0.006607 0.133563)
+(-0.000274 -0.001671 0.248073)
+(-0.006962 -0.005759 0.082289)
+(-0.000802 -0.006960 0.210051)
+(-0.000631 -0.005187 0.259750)
+(-0.005557 -0.008470 0.274329)
+(-0.007001 0.003070 0.116547)
+(-0.001779 0.004419 0.273787)
+(-0.001293 -0.007403 0.020943)
+(-0.007997 -0.002519 0.284823)
+(-0.008872 -0.007283 0.299350)
+(-0.000278 -0.000048 0.233613)
+(-0.006301 0.008206 0.278879)
+(-0.000308 0.009166 0.062436)
+(-0.004728 0.002919 0.073166)
+(-0.003873 0.002577 0.048642)
+(-0.008828 0.006533 0.095791)
+(-0.003985 -0.004216 0.249906)
+(0.002349 0.006360 0.161905)
+(-0.002583 -0.002879 0.171235)
+(-0.002490 0.002131 0.257644)
+(-0.006938 -0.005113 0.093949)
+(0.001388 -0.001899 0.263049)
+(0.007988 0.006491 0.138814)
+(-0.006481 0.004512 0.163290)
+(0.007662 0.000929 0.214017)
+(-0.005462 0.006698 0.161809)
+(0.003886 0.001981 0.284439)
+(-0.006672 0.005934 0.214858)
+(-0.000830 -0.001064 0.237824)
+(0.007983 0.002734 0.217806)
+(-0.007639 -0.003876 0.185440)
+(-0.004066 0.008598 0.117065)
+(-0.008186 0.003336 0.034855)
+(0.005498 0.001506 0.237269)
+(0.002012 0.005537 0.198764)
+(0.001740 0.009099 0.071125)
+(-0.007697 0.006834 0.036896)
+(-0.003192 -0.005670 0.180136)
+(0.001843 0.001158 0.138667)
+(0.009005 -0.007654 0.206782)
+(-0.001546 -0.001787 0.204637)
+(0.008116 -0.000105 0.256273)
+(0.008452 0.001680 0.102491)
+(0.004735 -0.007652 0.088774)
+(-0.005370 0.008861 0.220812)
+(0.001763 -0.001299 0.131596)
+(0.004063 -0.007582 0.009704)
+(0.006784 -0.003544 0.284850)
+(-0.001629 0.006092 0.029807)
+(0.003185 -0.001678 0.006145)
+(0.006831 0.003500 0.039226)
+(0.003561 0.001337 0.090469)
+(0.000259 -0.003259 0.246584)
+(-0.000414 0.008034 0.006445)
+(-0.006052 0.004561 0.104040)
+(-0.001452 -0.006880 0.093051)
+(0.001417 -0.001488 0.265632)
+(0.002877 0.004115 0.007531)
+(-0.006337 -0.007670 0.158821)
+(0.009020 -0.008383 0.018769)
+(0.006048 -0.004802 0.098364)
+(0.002108 -0.004723 0.279485)
+(-0.006813 0.008168 0.212270)
+(-0.001039 0.005326 0.177769)
+(0.007077 -0.000132 0.191694)
+(0.004548 -0.004659 0.097538)
+(0.007220 -0.007006 0.201470)
+(0.004278 -0.005813 0.018147)
+(0.002856 -0.000158 0.186330)
+(-0.008499 -0.005505 0.022110)
+(-0.007917 0.007410 0.262015)
+(0.005816 -0.004470 0.054877)
+(-0.001499 -0.007220 0.018201)
+(0.005888 -0.004293 0.274622)
+(-0.000331 -0.001995 0.042927)
+(0.001624 -0.002574 0.051988)
+(0.006659 0.006115 0.009668)
+(-0.005785 -0.000438 0.022161)
+(-0.003457 0.000861 0.082264)
+(0.005406 -0.003315 0.238068)
+(-0.006326 0.006476 0.197348)
+(-0.004375 0.004152 0.185870)
+(0.005661 0.002516 0.096299)
+(-0.000708 0.003562 0.054555)
+(0.009062 -0.004745 0.258239)
+(-0.000513 -0.000099 0.140648)
+(-0.002772 0.001245 0.223972)
+(-0.008937 -0.006767 0.101588)
+(0.006291 -0.000035 0.199275)
+(0.007971 -0.000667 0.238104)
+(0.006729 0.005023 0.198438)
+(-0.005718 0.008283 0.222749)
+(-0.003110 0.004071 0.080144)
+(-0.001074 0.000005 0.014766)
+(-0.002222 -0.008725 0.144642)
+(0.005542 -0.003213 0.189429)
+(0.000569 0.004670 0.252624)
+(-0.002824 -0.002473 0.296240)
+(-0.000557 0.003607 0.144514)
+(-0.005131 -0.001635 0.148194)
+(-0.003865 -0.008536 0.102420)
+(0.002844 0.004955 0.089480)
+(-0.000892 -0.002664 0.156927)
+(-0.002021 -0.005469 0.183029)
+(0.006725 -0.002435 0.169736)
+(-0.005911 0.002943 0.026960)
+(-0.005365 -0.004136 0.136077)
+(-0.003765 0.000737 0.101309)
+(-0.001168 -0.003802 0.139897)
+(-0.004978 -0.006666 0.111121)
+(0.003746 0.007709 0.134546)
+(-0.003467 -0.001184 0.181779)
+(-0.005213 0.000975 0.043786)
+(0.004106 0.004810 0.008807)
+(0.003723 -0.007507 0.122882)
+(0.000628 0.002943 0.273886)
+(-0.005746 0.004052 0.296133)
+(0.007369 0.003200 0.033453)
+(0.006347 -0.007280 0.170628)
+(0.003858 0.000719 0.019229)
+(-0.001388 -0.008885 0.079684)
+(0.001938 0.001634 0.146816)
+(-0.008953 -0.003826 0.085269)
+(0.001625 0.006734 0.127224)
+(-0.004965 0.008844 0.027601)
+(0.006689 -0.000685 0.253041)
+(0.002159 0.009197 0.155869)
+(0.007018 0.003490 0.188810)
+(0.000995 0.003909 0.094967)
+(-0.005214 0.000280 0.186452)
+(0.003675 0.002569 0.167221)
+(0.009138 0.000895 0.261714)
+(-0.007229 -0.002234 0.021164)
+(-0.004776 0.007833 0.274430)
+(-0.005291 -0.000788 0.019465)
+(-0.003825 -0.006319 0.050313)
+(0.004369 -0.004902 0.111862)
+(-0.004335 0.000019 0.098492)
+(0.007533 -0.003383 0.151749)
+(-0.001773 0.008721 0.027240)
+(0.004363 -0.007362 0.246169)
+(-0.001323 -0.004475 0.099407)
+(-0.001643 0.002799 0.148456)
+(-0.007368 -0.000635 0.169815)
+(0.005427 -0.004141 0.047154)
+(0.003013 0.006762 0.002705)
+(0.005703 0.001152 0.241008)
+(0.001789 -0.006532 0.146955)
+(-0.004209 0.002508 0.126831)
+(-0.006047 -0.007464 0.126559)
+(0.001337 0.003150 0.288380)
+(0.004450 0.000690 0.048622)
+(-0.004617 -0.004059 0.156989)
+(0.009138 -0.007880 0.265293)
+(0.001674 0.001990 0.172216)
+(-0.003067 0.005468 0.199072)
+(-0.002530 -0.001559 0.108142)
+(0.006519 0.002411 0.103932)
+(-0.007573 0.008612 0.047343)
+(-0.002965 -0.005109 0.050260)
+(-0.005655 0.000528 0.092682)
+(0.002019 0.006355 0.027430)
+(0.008614 0.004093 0.283046)
+(0.005047 -0.000219 0.286349)
+(0.008269 0.002909 0.122652)
+(0.004549 -0.009092 0.236052)
+(-0.004951 -0.000718 0.038537)
+(-0.005079 0.002660 0.199585)
+(0.006644 0.003658 0.092524)
+(0.004406 -0.000255 0.278267)
+(0.000440 0.006720 0.164549)
+(0.005641 -0.006037 0.244308)
+(-0.001716 0.000767 0.058793)
+(0.004639 0.000711 0.263521)
+(0.000009 0.005851 0.096401)
+(-0.003198 -0.002321 0.149258)
+(0.005190 0.004563 0.292731)
+(-0.008701 0.006865 0.115457)
+(0.003416 -0.002082 0.261791)
+(-0.005357 -0.002436 0.285317)
+(-0.006485 0.002100 0.063360)
+(0.000116 0.000539 0.108143)
+(-0.004927 -0.007145 0.040329)
+(0.006300 0.007708 0.281787)
+(-0.004117 0.007107 0.256734)
+(0.002828 -0.006517 0.056873)
+(0.002090 -0.008587 0.156567)
+(0.005385 -0.003512 0.230073)
+(-0.003930 0.000457 0.062085)
+(0.005146 -0.000973 0.057132)
+(0.004450 -0.004109 0.123312)
+(-0.007191 -0.006819 0.194615)
+(-0.001593 -0.006450 0.197371)
+(0.007780 -0.007760 0.135853)
+(-0.007577 0.007181 0.074607)
+(-0.009079 0.005985 0.199507)
+(0.007177 0.007467 0.111609)
+(0.008806 0.006073 0.153772)
+(0.005814 -0.004375 0.248474)
+(-0.001920 -0.001018 0.243562)
+(0.000180 -0.005503 0.245061)
+(-0.007501 -0.006774 0.207001)
+(0.004767 -0.002201 0.119621)
+(0.001656 -0.008529 0.276289)
+(-0.005227 -0.003370 0.059549)
+(0.005368 -0.008235 0.001010)
+(0.005379 0.008440 0.269684)
+(-0.002393 0.002763 0.294382)
+(0.002976 -0.002093 0.247512)
+(0.006864 -0.000793 0.299603)
+(0.002662 0.004390 0.270140)
+(0.005803 -0.006822 0.220986)
+(0.000193 0.002295 0.252202)
+(-0.001081 -0.007068 0.199619)
+(-0.002922 0.004590 0.178819)
+(0.008404 0.002105 0.109351)
+(0.005201 0.000833 0.236958)
+(0.006379 0.005425 0.111728)
+(0.000462 -0.007023 0.023668)
+(0.006668 0.002034 0.133608)
+(0.006927 -0.005793 0.225180)
+(-0.004957 -0.001158 0.207177)
+(-0.005211 -0.000567 0.119194)
+(-0.005634 0.007391 0.251137)
+(-0.006012 0.008331 0.060611)
+(-0.001878 0.002744 0.228010)
+(0.002742 -0.008148 0.019026)
+(0.008204 -0.006256 0.093529)
+(0.000393 -0.006070 0.178929)
+(-0.004356 -0.002873 0.218605)
+(-0.009136 -0.005236 0.286827)
+(-0.006380 -0.007291 0.093903)
+(0.008327 -0.002300 0.052768)
+(0.006655 0.003652 0.281634)
+(-0.001790 0.002679 0.140179)
+(-0.002940 0.000129 0.226517)
+(0.001146 0.001271 0.125602)
+(0.003883 -0.004187 0.221519)
+(-0.007291 0.007834 0.151288)
+(-0.000212 0.001285 0.212410)
+(-0.008586 0.001273 0.244139)
+(0.002322 0.005759 0.197555)
+(-0.004640 -0.004786 0.242559)
+(-0.006633 0.000356 0.294254)
+(0.003821 -0.005201 0.128764)
+(0.004056 0.002555 0.052241)
+(0.004596 -0.003053 0.241428)
+(0.003253 0.007813 0.235678)
+(0.003178 -0.006132 0.045812)
+(0.007146 -0.002324 0.036174)
+(0.004717 -0.004802 0.288897)
+(0.008257 0.007921 0.197041)
+(-0.006743 0.008484 0.282840)
+(-0.007371 0.002442 0.192925)
+(-0.003891 0.007283 0.039671)
+(-0.002063 0.005768 0.071992)
+(-0.008332 -0.000036 0.160639)
+(0.003940 -0.005970 0.090367)
+(-0.003067 0.008190 0.168870)
+(-0.003621 -0.008306 0.066531)
+(0.003143 -0.006900 0.061724)
+(-0.001911 -0.005009 0.014392)
+(-0.000898 0.005422 0.086393)
+(-0.002145 0.009083 0.068639)
+(-0.004681 -0.006909 0.132889)
+(-0.007433 -0.002008 0.256634)
+(0.005447 0.005674 0.279417)
+(-0.003702 0.008352 0.011667)
+(-0.005500 -0.007130 0.165509)
+(-0.003915 0.000215 0.269009)
+(0.003899 0.001922 0.161651)
+(0.006853 -0.004945 0.100257)
+(-0.003509 0.002404 0.259351)
+(-0.005620 -0.002193 0.024711)
+(0.008618 0.005490 0.295663)
+(0.005549 0.008573 0.167296)
+(-0.000914 -0.004349 0.200058)
+(-0.003628 -0.002137 0.079478)
+(0.000966 0.001869 0.157038)
+(-0.001384 -0.001768 0.054855)
+(0.006631 -0.003228 0.052352)
+(-0.001303 0.007921 0.192285)
+(-0.001729 -0.005454 0.223827)
+(-0.002138 0.004224 0.232440)
+(-0.008081 0.005926 0.207588)
+(0.007563 0.007302 0.030759)
+(0.007780 0.002208 0.084026)
+(-0.000358 -0.004157 0.129460)
+(0.009104 -0.001717 0.204205)
+(0.006683 0.008634 0.042872)
+(-0.005012 -0.001011 0.258274)
+(-0.002392 -0.001281 0.180826)
+(-0.008612 0.002047 0.091501)
+(0.003110 0.003492 0.010375)
+(-0.002068 0.006377 0.132372)
+(0.005987 -0.007830 0.227020)
+(0.008090 0.000078 0.040284)
+(-0.000281 -0.007064 0.066700)
+(-0.005761 0.004273 0.015352)
+(0.004801 0.000061 0.271771)
+(-0.004052 0.005836 0.108531)
+(-0.000028 0.003773 0.042179)
+(0.003220 0.005494 0.192229)
+(-0.003568 0.004249 0.017460)
+(-0.002812 -0.006033 0.237890)
+(0.005173 0.000541 0.067307)
+(0.002394 0.008091 0.247774)
+(-0.003373 0.005339 0.049098)
+(-0.006004 -0.005866 0.146369)
+(0.002083 0.008174 0.237992)
+(-0.002309 0.006658 0.266958)
+(-0.007444 0.000064 0.049472)
+(-0.004630 0.006894 0.132674)
+(0.006993 -0.002323 0.117625)
+(-0.001250 0.004285 0.075425)
+(-0.004936 0.005017 0.240927)
+(0.002939 0.003670 0.093481)
+(0.000512 0.008464 0.060912)
+(-0.000809 0.005963 0.123959)
+(0.001691 0.006138 0.288240)
+(-0.004825 -0.002917 0.172624)
+(-0.000049 0.007995 0.067829)
+(0.005390 -0.006183 0.009330)
+(-0.004547 -0.001826 0.076453)
+(0.001483 0.008041 0.078158)
+(-0.004139 0.006466 0.230786)
+(0.001849 0.004628 0.021197)
+(-0.007489 0.004027 0.113695)
+(0.003684 0.004305 0.220418)
+(-0.005866 -0.002058 0.112495)
+(0.005394 -0.009177 0.180149)
+(0.008557 0.003322 0.173663)
+(0.001796 -0.000335 0.236852)
+(0.001260 0.008021 0.114986)
+(0.005719 0.007907 0.066219)
+(-0.007215 -0.004121 0.038967)
+(0.002256 0.006636 0.124841)
+(0.003063 -0.004923 0.257385)
+(0.002840 0.007370 0.280869)
+(0.004912 -0.006870 0.269247)
+(-0.003280 0.003432 0.211764)
+(0.003746 -0.000114 0.218201)
+(0.009058 -0.006072 0.039159)
+(0.002869 0.000974 0.146745)
+(-0.004040 -0.001956 0.215817)
+(-0.004804 0.005469 0.201949)
+(-0.002582 -0.003867 0.055089)
+(0.002105 0.005549 0.061116)
+(0.001854 0.000461 0.153496)
+(-0.006304 -0.002802 0.022402)
+(0.004111 0.006038 0.147316)
+(-0.001835 -0.000553 0.231915)
+(0.001480 0.009123 0.125499)
+(0.002651 -0.008525 0.267480)
+(0.007223 0.004515 0.094210)
+(0.005718 0.006003 0.020011)
+(0.002254 0.000434 0.058197)
+(0.004999 0.002064 0.033889)
+(0.007251 -0.005265 0.013418)
+(-0.009069 0.001348 0.238670)
+(0.001797 -0.003095 0.239981)
+(-0.003001 0.003959 0.262843)
+(0.008150 -0.002993 0.061769)
+(-0.003404 0.008985 0.224856)
+(-0.000728 0.000801 0.240348)
+(0.004929 0.002193 0.293863)
+(0.006670 0.000752 0.034952)
+(-0.004564 -0.008243 0.011533)
+(-0.004147 0.005051 0.100884)
+(0.007530 0.003794 0.295255)
+(-0.007196 -0.005796 0.255558)
+(0.000229 -0.004946 0.175874)
+(-0.000282 0.008139 0.272376)
+(-0.007000 -0.002415 0.228054)
+(-0.009013 0.008931 0.019476)
+(0.003802 -0.002050 0.208987)
+(-0.008574 0.006910 0.285466)
+(0.000064 -0.008777 0.034638)
+(0.009044 0.008901 0.228143)
+(-0.000741 -0.009175 0.200185)
+(0.002352 -0.006970 0.127781)
+(-0.000389 -0.000282 0.285779)
+(0.008309 -0.002201 0.017290)
+(-0.001191 0.002689 0.196755)
+(-0.005566 -0.007903 0.260822)
+(0.007070 0.002160 0.294050)
+(-0.005649 -0.003331 0.031638)
+(0.000154 0.005793 0.069911)
+(0.001687 0.006828 0.116464)
+(-0.002776 0.007811 0.137797)
+(-0.007706 0.008965 0.243956)
+(-0.004958 0.007193 0.021336)
+(0.000918 -0.004716 0.066282)
+(0.008255 -0.005852 0.128155)
+(0.007628 -0.000793 0.203271)
+(-0.005123 0.000321 0.122875)
+(-0.002279 0.005258 0.217195)
+(0.003408 -0.000027 0.173280)
+(0.008131 -0.008428 0.101596)
+(-0.007519 0.001339 0.138122)
+(0.009185 -0.002428 0.038955)
+(0.002438 -0.008935 0.268091)
+(-0.004633 -0.001348 0.024629)
+(0.007115 0.001669 0.197967)
+(-0.000815 0.001787 0.194391)
+(-0.001211 0.007325 0.222719)
+(0.001986 0.004507 0.255980)
+(0.009013 0.007866 0.133194)
+(0.002196 -0.002218 0.245830)
+(-0.007076 -0.001892 0.145104)
+(0.005068 0.001367 0.154117)
+(-0.004510 -0.006796 0.023912)
+(0.006092 -0.003801 0.017510)
+(-0.007916 -0.008248 0.023889)
+(-0.001491 -0.005825 0.171324)
+(0.008486 0.004385 0.216005)
+(-0.002223 0.001436 0.290782)
+(-0.006529 0.002342 0.041046)
+(0.002484 0.007649 0.265743)
+(-0.003117 -0.006216 0.105566)
+(-0.008804 0.002406 0.091529)
+(0.001865 -0.002323 0.130463)
+(-0.001145 0.000117 0.265172)
+(0.004255 -0.007642 0.140604)
+(-0.006635 -0.008103 0.002780)
+(-0.005619 -0.009110 0.118115)
+(-0.005568 0.008493 0.210288)
+(-0.003455 -0.008544 0.059645)
+(-0.006808 -0.001982 0.039653)
+(-0.008323 0.001500 0.151535)
+(0.002702 0.008540 0.286533)
+(-0.002655 0.000373 0.068472)
+(0.003763 0.000944 0.021237)
+(0.008880 0.005509 0.255063)
+(0.001419 0.006495 0.277089)
+(0.001072 0.001729 0.152906)
+(-0.007703 0.001869 0.281131)
+(-0.001157 0.003032 0.025395)
+(-0.004774 0.008632 0.165836)
+(0.007970 -0.002619 0.285675)
+(-0.005363 -0.000177 0.170289)
+(-0.004156 0.004873 0.202999)
+(0.003317 -0.008505 0.071772)
+(-0.003168 -0.002447 0.182490)
+(-0.005912 -0.001441 0.140051)
+(-0.000282 -0.000116 0.229678)
+(-0.003163 0.002972 0.024329)
+(0.003106 0.001630 0.271987)
+(0.005837 0.001426 0.043458)
+(0.006243 0.007714 0.159252)
+(0.003488 -0.005865 0.266576)
+(-0.002334 0.006572 0.157311)
+(0.003183 -0.004935 0.156259)
+(0.005759 -0.005868 0.247938)
+(-0.004936 -0.008438 0.000472)
+(-0.003034 -0.001366 0.192524)
+(0.002955 -0.008062 0.036975)
+(0.005279 -0.003985 0.189530)
+(0.006469 -0.001629 0.030891)
+(-0.002802 -0.002115 0.058439)
+(0.008951 -0.003300 0.246030)
+(-0.000627 -0.003577 0.130358)
+(-0.007855 -0.006260 0.265988)
+(-0.004695 0.008305 0.048802)
+(-0.003969 0.001060 0.076232)
+(-0.001438 -0.004967 0.240960)
+(-0.007133 0.001785 0.023851)
+(0.004003 -0.001024 0.278419)
+(-0.000384 -0.001936 0.049936)
+(-0.003554 -0.002260 0.282330)
+(-0.003328 -0.005779 0.240284)
+(0.004417 0.006892 0.097055)
+(0.008791 -0.004387 0.109741)
+(0.007138 -0.008522 0.277552)
+(0.000101 -0.005432 0.061125)
+(-0.008092 -0.002676 0.022025)
+(0.003116 -0.008273 0.294979)
+(0.002975 -0.004024 0.226061)
+(-0.004407 0.001385 0.039787)
+(-0.000346 -0.002587 0.130952)
+(-0.000973 -0.001102 0.033684)
+(0.006195 -0.002649 0.272895)
+(0.003947 0.008484 0.178714)
+(-0.004536 0.003587 0.109392)
+(0.003613 0.001563 0.296259)
+(0.000864 -0.003124 0.150511)
+(-0.005825 0.001804 0.066675)
+(-0.007254 -0.003788 0.200488)
+(-0.002217 -0.006143 0.042990)
+(0.001171 -0.002710 0.251131)
+(-0.003211 0.004515 0.159253)
+(0.005035 -0.004445 0.003073)
+(0.002024 0.008822 0.176063)
+(-0.002289 0.002347 0.152776)
+(0.006286 -0.006298 0.014706)
+(-0.008247 0.003519 0.150834)
+(-0.008303 -0.005457 0.276704)
+(0.003331 0.006514 0.104106)
+(0.001168 -0.007490 0.297345)
+(-0.008635 0.002166 0.153565)
+(-0.004151 0.007013 0.196470)
+(0.005833 -0.002364 0.146831)
+(-0.005559 0.007137 0.012463)
+(-0.004116 0.008686 0.125115)
+(-0.002545 0.005813 0.274103)
+(0.006278 -0.001462 0.256781)
+(-0.006020 -0.008266 0.096468)
+(-0.000392 0.000796 0.156411)
+(-0.008834 0.004771 0.176102)
+(0.007814 0.007154 0.282011)
+(0.004996 -0.006837 0.277302)
+(0.006929 0.004986 0.143024)
+(0.004509 0.002701 0.075416)
+(0.008127 -0.006294 0.199544)
+(-0.000472 -0.006452 0.114108)
+(0.007775 -0.002048 0.272656)
+(0.000523 0.007641 0.116749)
+(0.002051 0.008618 0.013351)
+(-0.008183 -0.008434 0.247169)
+(-0.003321 -0.006463 0.225986)
+(0.007434 -0.000675 0.219606)
+(-0.000809 0.005823 0.045748)
+(-0.005064 -0.004202 0.163098)
+(-0.006139 0.005005 0.013327)
+(-0.001750 -0.004616 0.001842)
+(-0.007049 -0.004403 0.053379)
+(0.009004 -0.000530 0.087518)
+(-0.001339 -0.002788 0.195617)
+(-0.008463 -0.001605 0.119450)
+(0.006161 -0.007405 0.193670)
+(-0.009129 0.007705 0.211984)
+(0.007713 -0.000477 0.016947)
+(0.007265 -0.008093 0.201673)
+(-0.003814 -0.005250 0.044530)
+(-0.005512 -0.004229 0.152716)
+(0.005513 0.006628 0.049307)
+(-0.000327 -0.002136 0.095001)
+(0.003518 0.002390 0.253156)
+(0.009024 -0.002035 0.232816)
+(0.003067 0.007594 0.179014)
+(-0.006276 0.008729 0.025947)
+(-0.003489 0.007472 0.267471)
+(0.001580 0.008948 0.111826)
+(-0.003561 0.007318 0.098371)
+(0.004131 -0.003408 0.267806)
+(0.001943 0.004293 0.284358)
+(0.008274 0.001402 0.219856)
+(0.003481 0.006255 0.299153)
+(-0.004864 -0.008849 0.259707)
+(-0.002725 -0.004171 0.079088)
+(-0.006624 -0.001826 0.085203)
+(0.002333 0.006832 0.113885)
+(0.006293 -0.002835 0.148078)
+(0.008372 0.006315 0.254278)
+(0.006386 -0.006921 0.024939)
+(-0.003129 -0.009048 0.226603)
+(0.005504 -0.006745 0.105748)
+(-0.000177 -0.004881 0.131919)
+(0.007017 0.001216 0.286806)
+(0.001782 -0.003570 0.224245)
+(0.006293 -0.008357 0.269119)
+(0.004544 -0.003109 0.011313)
+(-0.007933 0.000631 0.028972)
+(-0.007605 0.002197 0.234899)
+(-0.003500 0.003336 0.275650)
+(-0.003182 -0.006990 0.202404)
+(0.001581 -0.007172 0.289520)
+(0.004434 -0.008157 0.206173)
+(0.001122 -0.003289 0.090021)
+(-0.008118 -0.004694 0.109994)
+(0.008592 0.008198 0.156864)
+(-0.002162 -0.005433 0.295363)
+(-0.000631 -0.002502 0.051801)
+(0.002839 0.004650 0.105561)
+(-0.008457 0.001402 0.016752)
+(0.004128 0.000885 0.196514)
+(0.005507 0.006984 0.022344)
+(0.006561 0.006256 0.040581)
+(0.005791 0.007202 0.134764)
+(-0.002828 0.002291 0.204992)
+(0.001837 0.003198 0.248429)
+(-0.001945 0.008266 0.240026)
+(-0.006270 -0.001326 0.292504)
+(-0.005350 0.000943 0.179303)
+(-0.002254 -0.008272 0.216785)
+(-0.007404 -0.002891 0.241271)
+(0.007626 0.005412 0.296848)
+(0.000613 -0.000166 0.101450)
+(-0.004955 -0.003194 0.046056)
+(-0.008357 -0.006912 0.056087)
+(0.004972 -0.000972 0.258980)
+(0.002910 0.004258 0.130677)
+(0.001315 0.002961 0.047313)
+(-0.006698 -0.004754 0.144431)
+(0.006931 0.005335 0.152264)
+(-0.003129 -0.001458 0.110700)
+(-0.000683 0.004308 0.057795)
+(-0.001659 -0.004045 0.196533)
+(0.001744 0.008697 0.008174)
+(-0.003425 0.002003 0.015074)
+(-0.001717 0.005210 0.189464)
+(-0.007156 0.008634 0.227964)
+(-0.007418 -0.000056 0.199276)
+(0.006069 -0.003029 0.111241)
+(-0.008006 -0.006196 0.204891)
+(-0.008508 0.005444 0.292914)
+(-0.004078 0.006194 0.287650)
+(-0.003810 -0.000704 0.051691)
+(-0.006812 0.007811 0.096844)
+(-0.002746 0.008054 0.090585)
+(0.006287 -0.001765 0.106850)
+(-0.002048 0.008056 0.128375)
+(-0.008474 -0.001450 0.008404)
+(0.002431 0.004726 0.272618)
+(-0.000363 0.008777 0.181045)
+(-0.006538 0.003792 0.043775)
+(0.004216 0.003197 0.082237)
+(0.004865 -0.001875 0.252202)
+(0.000254 -0.001290 0.032622)
+(0.009146 -0.006667 0.169673)
+(0.007313 -0.005611 0.117564)
+(0.003305 0.008168 0.227817)
+(0.002361 0.000969 0.022352)
+(0.000527 -0.000290 0.084320)
+(0.002179 -0.001606 0.194513)
+(0.008530 -0.002501 0.032605)
+(0.000180 0.006382 0.092023)
+(0.001734 -0.003738 0.196013)
+(-0.006689 -0.005704 0.216424)
+(0.002793 -0.008789 0.017646)
+(0.000111 -0.004163 0.282327)
+(0.006142 -0.000073 0.103279)
+(0.002445 0.000824 0.219272)
+(-0.004284 0.003848 0.009559)
+(0.000068 -0.003267 0.167580)
+(-0.001333 -0.008997 0.082593)
+(0.004812 0.002693 0.087446)
+(-0.001518 -0.008943 0.081949)
+(0.007859 0.003609 0.036090)
+(-0.003286 -0.003852 0.040783)
+(0.004758 -0.002235 0.273737)
+(-0.003532 0.008712 0.027517)
+(0.004619 -0.004805 0.016774)
+(0.003780 0.008636 0.265743)
+(-0.005607 -0.005323 0.290244)
+(0.000024 0.001793 0.091556)
+(0.007124 -0.005573 0.045790)
+(-0.006764 0.008021 0.072445)
+(-0.006296 -0.008775 0.194916)
+(0.003074 -0.005882 0.255620)
+(-0.006379 -0.005549 0.232464)
+(0.008886 -0.002396 0.213629)
+(-0.007989 0.007806 0.223917)
+(-0.006346 0.003794 0.220806)
+(-0.002669 -0.007980 0.029093)
+(0.005697 0.002109 0.160719)
+(0.002625 -0.007425 0.133441)
+(-0.005278 0.008504 0.214357)
+(0.000844 0.008853 0.046885)
+(-0.001830 0.003355 0.289123)
+(-0.002144 0.003885 0.193684)
+(-0.003328 0.001118 0.161464)
+(0.001792 -0.005965 0.072545)
+(0.002342 0.009017 0.152826)
+(0.003553 -0.002171 0.286566)
+(0.008358 -0.008681 0.241776)
+(-0.004393 0.001523 0.054192)
+(0.007718 0.009081 0.214151)
+(-0.007545 0.002037 0.216373)
+(-0.000201 0.004662 0.051729)
+(0.001209 -0.000759 0.026680)
+(0.005481 -0.006624 0.175855)
+(0.004934 -0.008665 0.241074)
+(-0.009164 0.003592 0.202159)
+(0.006795 -0.006054 0.216609)
+(0.008068 0.003201 0.103196)
+(-0.001580 0.008763 0.062699)
+(-0.003418 -0.003727 0.102650)
+(0.004171 0.000794 0.147252)
+(0.008336 -0.004101 0.094535)
+(-0.005526 -0.006309 0.144130)
+(0.001343 -0.007445 0.060500)
+(-0.006838 0.007359 0.126100)
+(0.005776 -0.006031 0.148223)
+(0.008898 0.001018 0.070245)
+(0.001514 0.006498 0.294580)
+(0.004082 0.005461 0.136314)
+(0.004128 -0.000877 0.045497)
+(0.002468 -0.006584 0.025324)
+(-0.004747 0.003453 0.243494)
+(-0.002076 -0.002147 0.125795)
+(-0.000116 -0.005473 0.001184)
+(-0.007510 0.004941 0.193393)
+(-0.004443 -0.008755 0.207949)
+(-0.000945 0.004394 0.146188)
+(0.001614 -0.004930 0.250504)
+(0.001246 0.000386 0.265452)
+(0.005558 -0.007135 0.294302)
+(-0.009058 0.007034 0.134177)
+(-0.007976 0.006363 0.266632)
+(-0.008857 0.007220 0.049857)
+(-0.007267 0.004069 0.138154)
+(-0.005060 -0.004316 0.223463)
+(0.002775 0.000479 0.067035)
+(0.007531 0.003882 0.181019)
+(-0.006224 0.008292 0.168401)
+(0.008879 0.007169 0.255328)
+(0.005369 -0.007239 0.071013)
+(0.003652 0.000919 0.194586)
+(0.002579 -0.005459 0.265783)
+(0.005758 -0.002187 0.205806)
+(0.007368 0.005224 0.165702)
+(0.000831 -0.000454 0.075555)
+(0.007741 0.000138 0.135592)
+(-0.005165 0.000721 0.204083)
+(-0.007124 -0.006870 0.254596)
+(0.007317 0.002805 0.018655)
+(0.003915 0.003239 0.245997)
+(-0.000245 -0.001734 0.233090)
+(-0.001143 -0.002862 0.246393)
+(0.000724 0.003304 0.080420)
+(0.008586 0.005282 0.275226)
+(-0.006771 0.003534 0.177774)
+(-0.002711 0.006796 0.175173)
+(-0.007429 0.000264 0.005394)
+(-0.007859 -0.008481 0.051256)
+(-0.003369 0.008026 0.041468)
+(0.001448 0.007688 0.170261)
+(0.003343 0.000133 0.070311)
+(-0.007965 -0.005898 0.198387)
+(-0.000791 0.003324 0.091787)
+(-0.002289 -0.009140 0.015821)
+(-0.004034 0.005383 0.216813)
+(0.002822 -0.004550 0.254760)
+(0.008010 -0.004504 0.031119)
+(-0.008908 0.008249 0.257195)
+(-0.000503 0.006508 0.287479)
+(0.001962 -0.005843 0.108123)
+(-0.008465 0.003900 0.219860)
+(-0.007997 0.009198 0.073308)
+(-0.007207 0.006626 0.268535)
+(-0.001887 0.007916 0.137238)
+(-0.001785 -0.001104 0.143453)
+(0.007870 0.005380 0.028765)
+(-0.000765 0.008506 0.136491)
+(0.004937 0.008137 0.265897)
+(0.001367 -0.002753 0.100942)
+(0.005906 0.002255 0.200982)
+(-0.006984 -0.008357 0.275942)
+(-0.002526 -0.008005 0.153644)
+(0.007209 -0.007993 0.011722)
+(0.002012 -0.002458 0.130157)
+(0.001228 -0.004468 0.194370)
+(-0.005851 -0.004259 0.202384)
+(-0.004116 0.003350 0.173351)
+(-0.004806 -0.000535 0.200916)
+(-0.005243 0.007939 0.225194)
+(-0.000413 0.000163 0.176418)
+(0.005259 -0.008135 0.144509)
+(0.005288 -0.004532 0.108404)
+(-0.008100 -0.007721 0.075669)
+(-0.008300 0.000014 0.012959)
+(-0.005291 -0.005112 0.067304)
+(-0.001449 -0.003023 0.270545)
+(0.002701 0.007522 0.211795)
+(0.007013 0.007143 0.184500)
+(0.005880 -0.004623 0.068017)
+(-0.000837 0.004494 0.121631)
+(-0.001311 -0.005744 0.219629)
+(0.008733 -0.007802 0.108692)
+(0.003337 -0.006068 0.207418)
+(0.004325 0.006564 0.017353)
+(0.000132 0.003485 0.025248)
+(-0.007080 -0.003786 0.273989)
+(0.007241 0.000012 0.215318)
+(-0.003101 0.008636 0.269701)
+(0.002051 0.009078 0.133827)
+(0.003119 0.005006 0.116120)
+(-0.005434 -0.000407 0.081162)
+(-0.005572 0.008333 0.245127)
+(0.005253 0.000900 0.047844)
+(0.002533 0.008320 0.052946)
+(0.004072 0.007512 0.293995)
+(0.005774 0.003880 0.101359)
+(0.008766 -0.005826 0.280176)
+(-0.007011 -0.007496 0.049074)
+(-0.003215 0.004188 0.056731)
+(0.002127 0.006993 0.008747)
+(-0.002101 0.005215 0.060138)
+(0.003414 -0.007810 0.279771)
+(-0.006611 -0.003480 0.212884)
+(0.009063 0.008916 0.258108)
+(0.004506 0.008973 0.230684)
+(-0.003963 -0.008004 0.141541)
+(-0.000900 0.006197 0.146672)
+(-0.001102 0.004273 0.261798)
+(0.002312 -0.003058 0.233487)
+(0.003795 0.003504 0.077358)
+(0.002930 -0.004461 0.148780)
+(0.009152 -0.002705 0.206924)
+(0.004021 0.003141 0.048551)
+(0.004516 -0.005511 0.083911)
+(-0.002386 0.008980 0.159455)
+(-0.007766 -0.006237 0.254530)
+(0.003831 -0.003399 0.029176)
+(0.008728 0.003162 0.225292)
+(0.004468 0.002561 0.288010)
+(0.004209 0.007493 0.231311)
+(-0.008327 -0.000417 0.218975)
+(-0.006257 -0.004187 0.221137)
+(0.001233 0.004068 0.158190)
+(-0.002671 -0.000334 0.247669)
+(0.000090 -0.001147 0.007020)
+(-0.008617 -0.002026 0.175388)
+(-0.005541 0.005038 0.009061)
+(-0.006016 0.008876 0.292159)
+(0.002911 0.002189 0.044996)
+(0.006002 -0.004696 0.087269)
+(0.003184 -0.001100 0.073130)
+(-0.001372 0.004282 0.142867)
+(0.003926 -0.001482 0.062673)
+(0.003537 0.003781 0.216827)
+(0.007845 -0.005505 0.040381)
+(-0.002472 0.001395 0.295939)
+(0.000702 -0.006662 0.052525)
+(0.006028 0.001729 0.144140)
+(0.001044 -0.000114 0.094996)
+(-0.002564 0.001929 0.216923)
+(-0.000255 0.003919 0.220518)
+(-0.007736 -0.002128 0.239794)
+(0.000787 -0.000217 0.013344)
+(-0.005714 0.003000 0.086516)
+(0.004421 -0.007175 0.040739)
+(0.007262 0.006147 0.014232)
+(-0.008305 -0.000229 0.058958)
+(-0.005046 0.001922 0.264319)
+(0.005772 -0.007189 0.049449)
+(-0.003693 -0.000224 0.193074)
+(-0.000374 0.003938 0.083360)
+(0.005995 0.002184 0.119875)
+(0.006469 0.005097 0.241584)
+(0.003617 0.002732 0.216153)
+(-0.005294 0.002992 0.201942)
+(-0.003465 0.004201 0.249891)
+(0.004429 0.007051 0.258055)
+(-0.001191 -0.004920 0.220407)
+(0.004180 -0.000367 0.191431)
+(0.007144 0.008037 0.237616)
+(0.002420 0.003220 0.219268)
+(-0.007076 0.007550 0.198069)
+(-0.000669 0.001697 0.055211)
+(-0.005497 -0.000070 0.144690)
+(0.009151 0.004374 0.073843)
+(-0.001297 -0.002585 0.215113)
+(-0.004937 -0.001045 0.250213)
+(0.006556 0.000008 0.031079)
+(-0.008842 -0.003163 0.269826)
+(-0.005268 -0.008122 0.025799)
+(0.000896 -0.002255 0.295537)
+(-0.001514 -0.008203 0.068961)
+(0.003256 -0.006391 0.168496)
+(-0.005941 -0.007335 0.085194)
+(-0.004689 0.005332 0.125614)
+(-0.004915 -0.002479 0.067703)
+(-0.008414 0.004810 0.033034)
+(-0.008204 0.005818 0.233542)
+(-0.007746 0.000233 0.202622)
+(0.001334 -0.002074 0.011493)
+(0.008760 0.000532 0.013180)
+(-0.004962 0.007088 0.037924)
+(-0.007552 -0.002723 0.156572)
+(0.001199 -0.005876 0.225993)
+(0.007777 0.001805 0.269348)
+(-0.005768 -0.005789 0.238237)
+(0.007032 -0.000114 0.251444)
+(-0.003271 -0.002018 0.062387)
+(-0.007698 0.004774 0.222082)
+(-0.006171 -0.004106 0.050283)
+(-0.006832 0.004861 0.226851)
+(0.005918 0.007116 0.157544)
+(0.005678 -0.005409 0.206199)
+(-0.006660 -0.002752 0.049099)
+(-0.008944 0.000759 0.134661)
+(0.000371 0.007008 0.144689)
+(-0.001561 -0.002362 0.159287)
+(-0.005153 -0.001138 0.069298)
+(-0.004945 -0.001494 0.138239)
+(0.007842 -0.004413 0.002140)
+(-0.003566 0.004165 0.172585)
+(-0.008883 -0.003797 0.297544)
+(0.002199 0.001830 0.058541)
+(0.006444 0.002301 0.173688)
+(-0.006049 -0.000606 0.080781)
+(-0.000894 0.008128 0.177903)
+(-0.006213 0.008510 0.009609)
+(-0.003752 -0.000984 0.156880)
+(0.001138 0.000337 0.202838)
+(-0.007860 0.002700 0.215374)
+(-0.002701 -0.005665 0.005373)
+(-0.002808 -0.005726 0.043607)
+(-0.004104 0.003058 0.288658)
+(0.003691 0.003049 0.121790)
+(0.003668 -0.000298 0.176682)
+(-0.003217 0.008693 0.056846)
+(0.008010 0.000700 0.286932)
+(-0.000289 0.004921 0.277842)
+(-0.005322 -0.001510 0.123733)
+(-0.005692 -0.007301 0.293308)
+(0.004275 -0.004973 0.274622)
+(0.001254 -0.008966 0.221235)
+(0.001493 0.007727 0.157767)
+(0.005867 -0.003370 0.101924)
+(0.007541 -0.002786 0.285682)
+(0.006013 -0.001573 0.121782)
+(-0.000014 -0.001741 0.141155)
+(-0.003647 0.001062 0.296891)
+(-0.006548 -0.000310 0.089322)
+(0.007982 0.000214 0.153619)
+(0.009118 -0.002800 0.069681)
+(-0.004392 -0.003247 0.070706)
+(-0.003241 0.006638 0.056059)
+(-0.003345 -0.002647 0.004261)
+(0.007365 -0.005489 0.214932)
+(0.009195 -0.005656 0.220189)
+(-0.006301 0.005152 0.016201)
+(0.003322 0.007514 0.121791)
+(0.006002 0.003419 0.019571)
+(-0.003369 -0.002833 0.233843)
+(-0.005725 -0.000455 0.174752)
+(0.008300 0.006501 0.094071)
+(0.007191 0.003693 0.280616)
+(-0.005845 0.003119 0.196407)
+(0.007141 0.008982 0.118735)
+(-0.007177 -0.004064 0.040187)
+(-0.000362 0.000080 0.112745)
+(-0.006581 -0.002910 0.072200)
+(0.004698 0.005289 0.202542)
+(-0.004307 0.005671 0.107797)
+(0.007675 0.001101 0.010415)
+(0.002574 -0.008534 0.153515)
+(0.008584 0.006329 0.298440)
+(-0.001316 -0.007776 0.020396)
+(0.002167 -0.006081 0.187963)
+(-0.000564 0.004653 0.165219)
+(-0.005044 -0.008236 0.107200)
+(0.000254 0.002333 0.169819)
+(-0.000822 -0.002785 0.113960)
+(-0.001766 0.000309 0.269575)
+(0.005143 -0.008385 0.287290)
+(-0.007928 -0.003945 0.280331)
+(-0.008132 0.001567 0.111414)
+(-0.008491 0.007345 0.050569)
+(-0.003599 -0.004977 0.273939)
+(0.002267 -0.004649 0.077914)
+(-0.000396 -0.002325 0.223689)
+(0.002109 -0.003352 0.076704)
+(0.007133 -0.007882 0.186043)
+(0.001058 0.004922 0.258053)
+(0.008486 -0.003179 0.004984)
+(0.000454 -0.009058 0.090265)
+(-0.009078 0.006679 0.131223)
+(-0.000281 0.007508 0.105735)
+(0.008899 0.006001 0.282654)
+(-0.005648 0.001830 0.161715)
+(0.001544 -0.008572 0.237176)
+(0.005529 -0.005616 0.159520)
+(0.001021 0.000589 0.052190)
+(-0.001243 0.002939 0.035266)
+(0.008065 0.004588 0.253609)
+(0.005172 0.002678 0.247605)
+(0.004340 -0.008541 0.110271)
+(0.007037 -0.005143 0.113348)
+(-0.006051 0.008673 0.204672)
+(-0.003748 0.008545 0.027508)
+(0.002397 -0.001120 0.039183)
+(-0.002545 0.001179 0.122207)
+(0.002162 0.004123 0.289076)
+(-0.001362 0.001850 0.282083)
+(-0.000740 0.007503 0.051933)
+(-0.002290 0.004969 0.165750)
+(-0.007918 0.006374 0.165458)
+(-0.006470 -0.003175 0.107494)
+(0.002700 0.002058 0.285807)
+(-0.000238 -0.003594 0.239055)
+(0.001067 -0.007445 0.055020)
+(0.007993 0.004159 0.231733)
+(-0.005381 -0.006519 0.145469)
+(-0.003196 -0.000061 0.125979)
+(0.004205 0.005517 0.255763)
+(0.002023 0.002844 0.167949)
+(0.005391 0.003845 0.283737)
+(-0.004471 -0.005415 0.179516)
+(0.002765 -0.002354 0.032839)
+(-0.007691 -0.003810 0.293089)
+(0.005327 0.008691 0.266782)
+(0.006539 -0.006202 0.156083)
+(-0.000270 0.005955 0.162563)
+(0.006978 0.004245 0.169939)
+(0.004676 -0.002459 0.034671)
+(-0.005960 0.003211 0.285586)
+(-0.007864 0.008252 0.147307)
+(-0.003555 -0.000357 0.157849)
+(0.001440 0.006627 0.111696)
+(0.005521 -0.005007 0.185728)
+(-0.005464 -0.001480 0.143972)
+(-0.001183 0.002681 0.160175)
+(0.007316 0.006534 0.213162)
+(0.009093 -0.002740 0.186177)
+(-0.000005 -0.007975 0.075203)
+(0.002562 -0.002823 0.259953)
+(0.001013 0.002596 0.001997)
+(-0.000161 0.006956 0.003131)
+(-0.005026 -0.004150 0.073933)
+(0.001784 -0.007191 0.192977)
+(0.007394 0.000029 0.026732)
+(-0.001066 0.008915 0.175532)
+(0.003320 -0.004246 0.152524)
+(-0.003284 -0.001880 0.227598)
+(-0.001024 -0.000885 0.235841)
+(0.003461 -0.004390 0.195763)
+(0.001447 0.005868 0.122848)
+(-0.007000 -0.006737 0.268074)
+(0.003015 -0.008202 0.226412)
+(-0.002241 -0.004397 0.244596)
+(0.002723 0.007151 0.193154)
+(-0.002095 -0.004381 0.034131)
+(-0.004333 -0.006491 0.025189)
+(0.004646 0.006530 0.060062)
+(-0.004787 0.001340 0.288488)
+(-0.004605 -0.002653 0.201156)
+(-0.004764 -0.004899 0.008091)
+(-0.006277 0.007923 0.122373)
+(0.005859 -0.007634 0.101721)
+(0.005321 -0.001155 0.189537)
+(-0.007982 0.004792 0.219139)
+(-0.003773 0.008911 0.034241)
+(-0.001664 0.006813 0.015175)
+(-0.000604 0.001983 0.195676)
+(-0.000074 -0.002886 0.282363)
+(0.000821 -0.006663 0.059043)
+(0.006075 0.000734 0.149260)
+(0.006019 0.005576 0.279922)
+(-0.008496 -0.000210 0.289429)
+(0.005466 -0.005454 0.063834)
+(0.003769 -0.001804 0.139009)
+(-0.002389 -0.009032 0.055201)
+(0.008131 -0.001449 0.222893)
+(-0.002698 0.006939 0.008232)
+(0.002854 -0.006241 0.048950)
+(0.004804 0.003446 0.152214)
+(-0.007105 -0.005193 0.225653)
+(-0.007999 0.002433 0.288851)
+(-0.006915 -0.008526 0.039453)
+(0.005812 -0.004570 0.113593)
+(0.001161 0.005346 0.009227)
+(0.002811 -0.005862 0.255434)
+(-0.001478 0.002621 0.245798)
+(0.002080 -0.000695 0.052783)
+(-0.002911 -0.005036 0.072716)
+(-0.005733 -0.003914 0.295030)
+(-0.006991 0.000713 0.021233)
+(-0.000923 -0.005532 0.205147)
+(0.004949 -0.004557 0.181632)
+(-0.004529 -0.007229 0.064795)
+(-0.005791 0.003963 0.250056)
+(0.001667 -0.004435 0.197328)
+(0.001140 -0.006948 0.207940)
+(0.002859 0.004077 0.019972)
+(0.000671 -0.008346 0.108392)
+(-0.009091 0.005243 0.093071)
+(-0.007059 0.001326 0.191104)
+(0.004111 -0.007299 0.222309)
+(-0.008986 0.002803 0.085261)
+(-0.001347 -0.000816 0.165072)
+(0.007121 0.000329 0.063326)
+(-0.006719 -0.005302 0.095715)
+(0.003795 -0.008404 0.095965)
+(0.000183 -0.001775 0.144982)
+(-0.004320 0.007608 0.150288)
+(0.008655 -0.005729 0.078428)
+(-0.003317 -0.005259 0.234084)
+(-0.002897 -0.003174 0.188813)
+(0.004561 0.002100 0.019774)
+(0.006472 0.001969 0.137945)
+(-0.001973 -0.005018 0.295931)
+(0.004810 0.004097 0.069450)
+(-0.002632 0.006661 0.248138)
+(-0.008624 -0.008124 0.217079)
+(0.002951 -0.001400 0.125264)
+(-0.006310 -0.005970 0.269085)
+(-0.008439 -0.007765 0.108332)
+(-0.005462 0.006188 0.262071)
+(0.007026 -0.006486 0.133000)
+(-0.006230 -0.008123 0.049407)
+(-0.002486 -0.008198 0.286073)
+(-0.001711 0.006781 0.112496)
+(0.008450 0.000817 0.207637)
+(0.000363 -0.003769 0.063300)
+(-0.002923 -0.000688 0.162670)
+(-0.006501 -0.005401 0.235027)
+(0.008331 -0.004022 0.117375)
+(-0.003933 -0.003493 0.003560)
+(-0.003089 -0.001542 0.127731)
+(-0.000313 -0.000610 0.055129)
+(-0.006201 0.002433 0.172967)
+(0.008580 -0.000265 0.105882)
+(-0.003996 0.005217 0.234050)
+(0.004496 -0.003018 0.005882)
+(0.004697 0.002966 0.139614)
+(0.008302 -0.004672 0.041071)
+(-0.004394 -0.006006 0.296405)
+(0.003931 0.002959 0.278076)
+(-0.006410 -0.005767 0.262202)
+(0.008430 -0.000360 0.167638)
+(-0.006584 0.002116 0.006886)
+(-0.004461 0.008690 0.265831)
+(0.001981 0.004430 0.073901)
+(-0.001672 -0.004180 0.195255)
+(0.006362 -0.003434 0.291846)
+(0.000125 0.002966 0.180526)
+(-0.005333 0.008875 0.178585)
+(0.004780 -0.006757 0.296055)
+(-0.006278 0.002560 0.253200)
+(0.008315 -0.003465 0.259377)
+(-0.004218 0.004548 0.064932)
+(-0.002822 -0.001947 0.279579)
+(0.006615 -0.004163 0.244921)
+(0.007169 -0.007314 0.224862)
+(0.003367 0.003264 0.213557)
+(-0.002346 0.001793 0.144295)
+(0.005540 -0.007179 0.164436)
+(0.007502 0.003726 0.169730)
+(0.003916 -0.000962 0.221634)
+(-0.004258 0.001983 0.069162)
+(-0.004203 0.005881 0.196844)
+(0.001746 0.007328 0.049714)
+(-0.008158 -0.003311 0.108595)
+(0.002280 0.003998 0.133347)
+(0.006299 -0.008682 0.166354)
+(-0.000496 0.005655 0.238872)
+(0.003743 -0.005154 0.279219)
+(-0.008954 0.004924 0.119475)
+(0.001187 -0.007072 0.058856)
+(-0.003189 0.003825 0.018723)
+(0.003575 0.002556 0.206462)
+(0.002902 0.008623 0.048894)
+(0.002712 0.007623 0.220813)
+(0.000625 0.007958 0.075921)
+(-0.007206 -0.002090 0.073680)
+(0.006975 0.006370 0.043596)
+(-0.001011 -0.005662 0.297953)
+(-0.006651 0.001664 0.267625)
+(-0.008323 0.000851 0.164188)
+(-0.004056 -0.006835 0.083297)
+(-0.007834 0.002536 0.172283)
+(0.007064 -0.005139 0.138845)
+(-0.003085 0.000130 0.153494)
+(0.002114 -0.006316 0.155616)
+(0.003303 -0.003886 0.207839)
+(-0.001839 -0.002367 0.240213)
+(-0.004402 -0.005631 0.274653)
+(0.001691 0.007050 0.277098)
+(0.005530 -0.004898 0.272053)
+(0.004043 0.006148 0.155193)
+(-0.004253 0.004441 0.078990)
+(-0.000063 0.005989 0.116705)
+(-0.005439 -0.005543 0.249797)
+(0.003473 -0.007158 0.235374)
+(-0.000591 -0.005006 0.039221)
+(-0.003949 -0.005366 0.130022)
+(-0.005790 0.005043 0.246384)
+(0.005862 -0.002288 0.051584)
+(0.009061 -0.006332 0.046203)
+(-0.006610 0.001033 0.101476)
+(-0.004020 -0.008589 0.257233)
+(0.002556 0.005474 0.096348)
+(-0.003890 0.006556 0.064968)
+(0.004464 0.009124 0.140299)
+(0.000964 -0.004610 0.208370)
+(0.007385 0.004087 0.190367)
+(0.001343 -0.005552 0.187630)
+(0.004278 0.008573 0.267261)
+(0.006757 -0.000608 0.165832)
+(0.008060 -0.005090 0.107974)
+(0.001216 0.004214 0.297371)
+(-0.006725 0.000422 0.258653)
+(-0.001861 0.002761 0.267394)
+(0.005156 0.001817 0.104740)
+(-0.000758 0.008530 0.054952)
+(-0.000444 0.003800 0.243498)
+(0.004357 0.005733 0.251214)
+(-0.008718 -0.006950 0.044662)
+(0.004334 -0.007370 0.073103)
+(-0.003144 -0.005206 0.249183)
+(-0.009119 -0.007534 0.242735)
+(-0.000601 0.000325 0.087611)
+(-0.008865 0.000991 0.206410)
+(-0.006529 -0.004142 0.223103)
+(-0.001829 -0.006390 0.100652)
+(0.007134 0.008963 0.268327)
+(0.004749 -0.001575 0.190501)
+(-0.003203 0.006036 0.114188)
+(0.005657 0.005747 0.210048)
+(0.006934 0.006532 0.236470)
+(0.000954 0.000962 0.286329)
+(0.000917 0.006063 0.171553)
+(-0.002574 0.005433 0.151211)
+(0.005441 0.007045 0.171461)
+(0.007108 -0.002173 0.116077)
+(0.004028 -0.002431 0.169376)
+(-0.003915 -0.003245 0.200749)
+(-0.004665 0.004653 0.159882)
+(-0.001967 -0.004655 0.133258)
+(0.002363 0.005262 0.224175)
+(0.008691 0.008263 0.206508)
+(-0.005194 -0.002279 0.133017)
+(-0.001437 0.009092 0.086166)
+(0.001760 0.007533 0.045579)
+(-0.006724 -0.006579 0.283698)
+(0.007607 -0.001288 0.199314)
+(0.002148 0.004097 0.102107)
+(0.002106 -0.002434 0.068667)
+(-0.004022 0.004805 0.257394)
+(-0.007569 0.008856 0.231681)
+(0.003571 -0.007580 0.171297)
+(-0.003441 -0.001186 0.134747)
+(-0.009035 -0.000140 0.173739)
+(-0.006041 0.005557 0.129623)
+(-0.006430 0.001194 0.094465)
+(-0.008661 -0.007332 0.223419)
+(-0.000084 0.004258 0.091444)
+(0.002893 -0.005259 0.201199)
+(0.000823 -0.007162 0.056900)
+(-0.000507 0.004018 0.283772)
+(-0.001847 0.002515 0.154907)
+(0.003579 -0.004583 0.205269)
+(0.009106 -0.008692 0.252385)
+(-0.006180 0.000185 0.259412)
+(0.000196 -0.002897 0.250602)
+(0.001941 0.003536 0.201465)
+(0.002194 -0.002347 0.167605)
+(-0.002760 0.004114 0.274283)
+(-0.001874 0.002157 0.211083)
+(-0.002867 -0.004647 0.010860)
+(0.005406 -0.004098 0.122245)
+(-0.002932 -0.001527 0.166894)
+(0.004157 0.007804 0.228564)
+(0.000695 0.006938 0.021748)
+(0.007902 0.001000 0.075774)
+(-0.005098 0.002010 0.207617)
+(0.008797 0.007173 0.067073)
+(0.007868 0.001594 0.066703)
+(0.004306 0.001920 0.262034)
+(0.008575 0.002280 0.222649)
+(0.003147 -0.001407 0.275298)
+(0.005188 -0.007476 0.170649)
+(-0.006241 -0.001304 0.261486)
+(-0.003952 -0.009037 0.029507)
+(0.008255 -0.002658 0.261457)
+(0.002066 0.006208 0.088580)
+(-0.005773 -0.003729 0.102132)
+(-0.003958 0.002283 0.239514)
+(-0.003320 0.002301 0.183521)
+(-0.000109 0.008710 0.276222)
+(-0.004351 -0.000875 0.049804)
+(-0.007841 0.000227 0.298329)
+(0.006736 -0.001966 0.189316)
+(0.001079 -0.003395 0.140968)
+(0.007341 0.001505 0.190126)
+(0.002039 -0.002266 0.006154)
+(-0.004968 -0.002368 0.150478)
+(-0.003331 0.006483 0.237644)
+(-0.004640 0.003062 0.171709)
+(0.000231 -0.002534 0.057452)
+(0.003049 0.004858 0.053811)
+(-0.000196 -0.006697 0.096611)
+(0.009117 0.008187 0.030880)
+(-0.003781 -0.008388 0.019680)
+(0.008243 -0.002345 0.211432)
+(0.005287 -0.008047 0.076397)
+(-0.005161 -0.000080 0.044012)
+(-0.005566 -0.001702 0.291133)
+(-0.000019 -0.002318 0.100007)
+(0.008814 0.002151 0.181812)
+(0.008330 0.000862 0.082899)
+(-0.002473 0.005031 0.173721)
+(-0.005905 0.004606 0.221996)
+(-0.006629 0.002995 0.267665)
+(-0.000890 -0.001019 0.129338)
+(-0.001770 -0.003713 0.268123)
+(-0.002865 0.008800 0.046141)
+(-0.002402 -0.006884 0.033069)
+(-0.004186 -0.001288 0.143350)
+(0.004429 -0.003023 0.142717)
+(-0.004306 -0.008852 0.076328)
+(-0.006565 -0.004594 0.288344)
+(-0.000894 -0.000838 0.191527)
+(-0.008590 -0.006143 0.293314)
+(0.000947 0.003434 0.148760)
+(-0.001477 0.002205 0.145218)
+(-0.005438 0.007258 0.253347)
+(0.008809 0.001393 0.051511)
+(-0.001587 0.005003 0.281661)
+(0.008239 -0.003216 0.214412)
+(0.008000 -0.002429 0.257725)
+(0.003349 -0.007316 0.225340)
+(-0.004137 0.006552 0.219098)
+(0.007305 -0.001657 0.138244)
+(0.006396 0.001464 0.005628)
+(-0.004248 -0.008785 0.134820)
+(0.002358 -0.007275 0.118439)
+(-0.000753 0.005967 0.067155)
+(0.002002 0.001969 0.234797)
+(0.007154 -0.005342 0.159397)
+(0.000992 -0.000621 0.168106)
+(-0.002005 0.000936 0.216848)
+(0.001809 0.006801 0.005647)
+(-0.005144 0.001377 0.149408)
+(-0.005798 0.001324 0.174838)
+(0.001047 -0.007481 0.176608)
+(-0.009198 0.000551 0.184522)
+(0.001546 0.001563 0.137970)
+(0.000407 -0.005498 0.184279)
+(0.006705 0.007647 0.125819)
+(-0.005787 -0.001669 0.030100)
+(0.007333 -0.003381 0.278937)
+(0.004212 0.002369 0.179261)
+(-0.005427 -0.004796 0.053737)
+(0.002016 -0.006059 0.195303)
+(-0.002140 0.006632 0.020090)
+(-0.003313 -0.004977 0.009006)
+(-0.007355 0.002765 0.011789)
+(0.007149 -0.001657 0.042765)
+(0.000089 -0.007480 0.111375)
+(0.002837 0.006487 0.192134)
+(0.003487 -0.008853 0.080471)
+(0.008066 0.003733 0.273946)
+(0.001724 0.003983 0.091106)
+(0.007794 -0.005761 0.118166)
+(-0.001594 -0.002253 0.044868)
+(-0.000219 -0.001727 0.085802)
+(0.007127 -0.008371 0.155713)
+(-0.009126 0.002701 0.223875)
+(-0.000089 0.003117 0.266675)
+(0.002674 0.007649 0.003731)
+(0.002980 0.005465 0.086705)
+(0.006506 0.008574 0.289094)
+(-0.000010 0.001428 0.009829)
+(-0.002249 0.005437 0.220488)
+(-0.006603 0.006336 0.298451)
+(0.007408 -0.002189 0.239121)
+(-0.004667 -0.002274 0.286081)
+(-0.005135 -0.004519 0.127133)
+(-0.008097 -0.000846 0.220464)
+(-0.004670 -0.004450 0.231087)
+(-0.009057 0.007703 0.035428)
+(-0.007262 -0.008299 0.250166)
+(0.009090 0.002961 0.055112)
+(-0.006665 -0.002263 0.161808)
+(-0.000071 0.004146 0.268215)
+(0.006843 -0.005064 0.181909)
+(0.002403 -0.001835 0.001517)
+(0.006284 -0.005493 0.239515)
+(-0.008846 0.000206 0.164687)
+(0.007937 -0.006619 0.135257)
+(-0.005885 -0.007371 0.166104)
+(-0.003400 0.004880 0.135030)
+(-0.008479 -0.004326 0.058021)
+(-0.008220 -0.005232 0.109251)
+(-0.007537 0.003106 0.141130)
+(-0.004781 0.003645 0.256652)
+(-0.005562 0.000960 0.132735)
+(0.000280 -0.002899 0.137513)
+(-0.005636 -0.001495 0.274015)
+(0.005424 0.008675 0.089278)
+(0.008603 -0.009175 0.240934)
+(-0.002412 -0.001918 0.294194)
+(0.000268 -0.005581 0.279889)
+(0.004706 0.000827 0.142626)
+(-0.007093 0.001920 0.181456)
+(-0.007917 -0.008774 0.043323)
+(-0.001042 0.000009 0.149047)
+(-0.008661 0.006999 0.164221)
+(0.004620 0.003725 0.065716)
+(-0.002079 -0.007159 0.296359)
+(-0.000621 0.008614 0.190020)
+(0.002733 0.002173 0.298696)
+(0.008009 0.001892 0.298809)
+(-0.008204 0.004632 0.277746)
+(0.003709 0.003062 0.159222)
+(-0.000353 0.005433 0.060696)
+(-0.004918 -0.001642 0.210022)
+(0.001114 0.006992 0.210502)
+(-0.004553 0.000790 0.287789)
+(0.000677 -0.006245 0.228222)
+(0.008500 -0.006328 0.086026)
+(-0.003790 -0.002646 0.028925)
+(0.004699 0.000584 0.215662)
+(-0.008812 0.005653 0.086136)
+(-0.007548 0.002610 0.064576)
+(0.001516 -0.007825 0.221474)
+(-0.007580 0.000947 0.245383)
+(-0.007471 -0.007850 0.253843)
+(-0.003797 -0.004140 0.030774)
+(-0.007743 -0.007364 0.157621)
+(0.001028 -0.008753 0.175572)
+(0.002890 0.001065 0.140736)
+(0.004019 0.001131 0.247958)
+(-0.001726 0.000934 0.260472)
+(0.000451 -0.004774 0.265089)
+(-0.003963 0.004843 0.020919)
+(-0.003289 -0.005426 0.156379)
+(-0.007557 0.005308 0.055386)
+(0.006681 0.000201 0.143250)
+(-0.008912 -0.007632 0.296424)
+(-0.002713 0.004544 0.257284)
+(-0.005912 -0.000465 0.217539)
+(0.006932 -0.002065 0.044014)
+(-0.006135 0.000689 0.220106)
+(0.005121 0.004600 0.077659)
+(0.006898 -0.002682 0.137387)
+(-0.001968 -0.002994 0.253022)
+(-0.005057 0.007682 0.021055)
+(-0.003440 0.005097 0.026683)
+(-0.007232 -0.004750 0.225339)
+(-0.004399 0.005441 0.250799)
+(-0.008567 -0.006897 0.118030)
+(-0.008116 0.008365 0.086737)
+(-0.002493 0.000707 0.057906)
+(-0.008462 -0.002273 0.017464)
+(-0.000849 -0.007587 0.193598)
+(-0.003892 0.005807 0.216115)
+(-0.005456 0.003068 0.023483)
+(0.004304 -0.007897 0.115326)
+(-0.003326 -0.001814 0.059631)
+(-0.004491 -0.004025 0.234023)
+(0.003155 -0.006422 0.131274)
+(0.007558 0.005936 0.250002)
+(-0.007876 0.005092 0.243373)
+(-0.006378 -0.000246 0.060045)
+(-0.002534 -0.007466 0.119141)
+(0.002747 0.008390 0.245252)
+(0.002975 0.004577 0.163754)
+(-0.001476 -0.007605 0.270190)
+(-0.002316 -0.005705 0.243643)
+(0.000841 0.003244 0.074370)
+(0.006061 -0.005328 0.203080)
+(-0.005785 0.006482 0.199309)
+(-0.004573 0.008717 0.204668)
+(0.004441 0.004566 0.275425)
+(0.001556 0.004542 0.194660)
+(-0.004601 0.005669 0.067655)
+(0.002799 -0.009090 0.004804)
+(-0.009029 -0.002908 0.143045)
+(0.006403 -0.006254 0.192030)
+(0.001266 0.002697 0.150025)
+(0.003489 -0.006509 0.008573)
+(0.003642 -0.006111 0.274607)
+(-0.003218 -0.001111 0.210300)
+(0.001608 -0.002695 0.139671)
+(-0.008673 0.000939 0.042101)
+(0.004245 0.000185 0.061906)
+(-0.002531 0.006931 0.120783)
+(0.006132 -0.000652 0.116285)
+(0.003999 0.007811 0.150688)
+(-0.006289 0.007728 0.150416)
+(-0.007866 -0.008225 0.151905)
+(0.001500 0.002132 0.134947)
+(0.005702 -0.008836 0.039905)
+(-0.000262 -0.004477 0.253303)
+(-0.007520 0.008333 0.139682)
+(0.002510 -0.002899 0.295235)
+(-0.003478 0.007215 0.027317)
+(-0.005384 0.007536 0.138925)
+(0.006245 -0.003739 0.054849)
+(0.003475 -0.002030 0.183511)
+(0.002383 -0.001500 0.167252)
+(0.004329 -0.008096 0.039551)
+(0.001501 0.004183 0.221678)
+(-0.008160 -0.000575 0.197534)
+(0.005272 -0.000252 0.259283)
+(-0.004697 0.004774 0.274967)
+(-0.004545 0.006524 0.238360)
+(0.004513 -0.003626 0.089329)
+(0.001924 0.004743 0.231369)
+(-0.004774 -0.004107 0.166448)
+(-0.001160 -0.004498 0.085582)
+(0.001984 -0.005204 0.218365)
+(0.000205 -0.002870 0.084702)
+(0.003539 0.000116 0.004631)
+(-0.002416 0.003108 0.262183)
+(-0.006809 0.004531 0.096222)
+(-0.000238 0.004805 0.207535)
+(0.008356 0.003756 0.006945)
+(0.001691 0.001658 0.126002)
+(0.007852 0.003280 0.150673)
+(-0.002970 -0.001122 0.033048)
+(-0.000881 0.002107 0.144495)
+(-0.008337 0.000753 0.219834)
+(-0.005810 -0.004335 0.224814)
+(-0.008231 0.008498 0.013057)
+(0.006366 0.006499 0.235557)
+(0.006158 0.007016 0.070041)
+(-0.000582 0.002082 0.218578)
+(0.000621 0.007721 0.292888)
+(0.001291 -0.003152 0.078616)
+(0.002565 -0.004356 0.027512)
+(0.001793 -0.002606 0.176841)
+(0.001413 -0.000824 0.185727)
+(0.008530 0.000893 0.025251)
+(0.002769 -0.003127 0.067733)
+(-0.004513 -0.002099 0.079595)
+(0.004375 0.000742 0.054342)
+(0.001400 -0.000063 0.170816)
+(0.007231 -0.007021 0.289549)
+(0.004405 -0.004990 0.031307)
+(0.008325 -0.002947 0.200445)
+(-0.000857 -0.003154 0.031624)
+(-0.008471 -0.007587 0.277892)
+(-0.001000 -0.007541 0.081827)
+(0.007849 0.000015 0.196233)
+(-0.008062 -0.001361 0.018471)
+(0.005299 0.007393 0.090766)
+(-0.005156 0.004722 0.162964)
+(0.004994 -0.005153 0.228424)
+(0.006033 0.007308 0.233166)
+(0.001049 0.004447 0.189747)
+(0.005959 0.003089 0.217736)
+(-0.004453 0.001852 0.137702)
+(0.005754 -0.008734 0.024490)
+(-0.005901 0.001562 0.249118)
+(0.002086 0.003288 0.130268)
+(0.007633 -0.006010 0.241115)
+(0.001021 -0.001164 0.035398)
+(0.008522 -0.001392 0.181142)
+(-0.001187 0.006828 0.255677)
+(0.004645 -0.002159 0.282483)
+(-0.006162 0.006883 0.117319)
+(0.005643 -0.004119 0.082389)
+(0.009101 0.007094 0.043028)
+(-0.008990 0.005149 0.141202)
+(0.006641 -0.001434 0.164719)
+(0.008394 -0.006730 0.068112)
+(-0.001590 0.008293 0.090256)
+(0.002497 -0.001326 0.227369)
+(-0.003594 -0.001986 0.121309)
+(-0.007796 -0.001204 0.218740)
+(0.002059 -0.004746 0.018976)
+(0.009105 -0.006221 0.055367)
+(0.001549 0.005255 0.044447)
+(-0.000768 0.005629 0.269007)
+(-0.002765 0.004061 0.055959)
+(-0.002610 -0.007111 0.266384)
+(-0.008323 -0.008661 0.173931)
+(0.000350 0.007422 0.161873)
+(0.001328 -0.007558 0.052469)
+(0.008003 0.003846 0.200098)
+(0.005915 -0.002403 0.007004)
+(0.004545 -0.001916 0.202129)
+(-0.007744 -0.008797 0.114007)
+(-0.005197 0.005680 0.280601)
+(-0.008078 0.004755 0.035932)
+(-0.007696 0.002568 0.203001)
+(-0.003357 0.003171 0.093862)
+(0.004561 0.002542 0.213486)
+(0.005853 0.006645 0.278132)
+(-0.005710 -0.001366 0.189520)
+(-0.004907 -0.001672 0.244599)
+(-0.008937 0.002603 0.283679)
+(-0.000518 0.002964 0.071748)
+(-0.006683 0.001192 0.139836)
+(0.004477 0.008995 0.029178)
+(0.007818 -0.008045 0.119280)
+(0.000113 0.009158 0.000819)
+(-0.009136 -0.008083 0.177947)
+(-0.001584 -0.001255 0.232485)
+(0.007262 -0.007176 0.211379)
+(0.008482 -0.008286 0.215958)
+(-0.005577 -0.007587 0.111100)
+(-0.001112 0.005579 0.109893)
+(0.000775 0.002841 0.037149)
+(0.004236 0.005559 0.090931)
+(0.008716 -0.005040 0.183550)
+(-0.000011 0.000535 0.209514)
+(0.008952 0.008597 0.133628)
+(-0.002218 -0.002149 0.146448)
+(-0.000947 -0.005668 0.137948)
+(-0.009025 -0.000976 0.283080)
+(-0.001422 0.005163 0.040904)
+(-0.007729 0.000563 0.157718)
+(0.005413 -0.008523 0.056496)
+(0.002379 -0.002040 0.147316)
+(0.008149 -0.008831 0.055500)
+(0.008973 0.007952 0.034853)
+(-0.007258 0.002198 0.258397)
+(0.001623 -0.005561 0.218508)
+(0.000945 0.001666 0.292002)
+(0.005974 -0.001686 0.282504)
+(-0.003458 0.004950 0.292186)
+(0.007591 -0.000464 0.226159)
+(0.006167 -0.001698 0.063101)
+(0.008446 -0.000534 0.187804)
+(0.003840 -0.004238 0.252062)
+(-0.006415 0.004686 0.009502)
+(0.003271 0.002080 0.203143)
+(0.000296 0.006089 0.104211)
+(-0.000105 0.005620 0.245464)
+(-0.007315 0.009018 0.293635)
+(0.006606 -0.003711 0.143667)
+(-0.004467 0.007179 0.151698)
+(-0.009030 0.003392 0.071595)
+(-0.003629 0.005773 0.166644)
+(0.002649 -0.001949 0.221957)
+(-0.000764 -0.007596 0.042838)
+(-0.008663 -0.008624 0.187194)
+(-0.002350 -0.001855 0.225959)
+(-0.003141 -0.006421 0.171636)
+(0.004737 0.002841 0.173354)
+(-0.006454 -0.007226 0.191400)
+(0.006848 -0.000323 0.215460)
+(0.005792 0.004333 0.189893)
+(0.006116 -0.004698 0.068356)
+(0.006395 -0.000246 0.076849)
+(-0.007620 -0.007693 0.122443)
+(-0.006769 -0.000305 0.156001)
+(-0.006819 0.006363 0.002981)
+(-0.002262 -0.006206 0.243230)
+(-0.007031 -0.000485 0.203425)
+(0.000580 0.000814 0.229929)
+(-0.002164 -0.007823 0.208464)
+(0.007578 0.008397 0.195244)
+(-0.007487 0.007399 0.298764)
+(-0.003735 0.004257 0.014753)
+(0.001110 -0.006527 0.035401)
+(-0.004110 -0.003118 0.054278)
+(-0.001801 -0.009070 0.092028)
+(-0.001541 -0.001743 0.114274)
+(-0.002647 0.004858 0.151270)
+(0.002210 0.003485 0.248489)
+(0.007244 0.006736 0.036662)
+(0.004337 0.008609 0.014409)
+(0.005070 -0.000755 0.224185)
+(-0.003136 0.000933 0.111595)
+(-0.003872 0.008452 0.207225)
+(0.008912 0.002588 0.121634)
+(-0.006157 -0.003126 0.019695)
+(0.001935 -0.002211 0.166065)
+(-0.006982 0.001928 0.290967)
+(0.005018 0.007719 0.103495)
+(0.005255 -0.008084 0.003075)
+(0.000853 -0.000088 0.035220)
+(-0.007214 -0.007704 0.106625)
+(0.008773 -0.005255 0.122152)
+(-0.005110 -0.009179 0.289164)
+(0.007508 0.007469 0.062651)
+(-0.000138 -0.001546 0.164709)
+(0.002440 -0.005395 0.299959)
+(0.004585 -0.006036 0.014829)
+(-0.001683 -0.002375 0.002191)
+(0.007734 0.008933 0.096692)
+(-0.006850 -0.007019 0.084294)
+(-0.004225 -0.004556 0.022796)
+(0.004286 -0.005059 0.196790)
+(0.005175 -0.009044 0.072225)
+(-0.008386 -0.006555 0.125473)
+(-0.007290 0.001769 0.276184)
+(-0.007263 0.001367 0.284740)
+(0.007853 0.005683 0.025835)
+(-0.001928 -0.003055 0.077903)
+(0.002239 -0.002488 0.106398)
+(-0.004350 0.002230 0.066101)
+(-0.004505 0.008121 0.076830)
+(0.008878 -0.000311 0.061442)
+(0.006202 -0.003058 0.139400)
+(0.007494 -0.000904 0.293361)
+(-0.001345 -0.004934 0.224809)
+(-0.005101 0.009163 0.282974)
+(-0.001233 -0.005236 0.140389)
+(0.002354 -0.004155 0.062164)
+(0.002783 0.007383 0.292148)
+(-0.008967 0.004755 0.085061)
+(-0.005042 -0.000914 0.049427)
+(0.006670 0.005942 0.223138)
+(0.000365 0.003847 0.035990)
+(-0.000864 0.006319 0.256149)
+(0.006041 0.000506 0.066957)
+(0.005375 0.007854 0.121942)
+(-0.002999 0.004253 0.048701)
+(0.008298 -0.003398 0.166362)
+(-0.008986 0.003374 0.284990)
+(0.002515 -0.007635 0.035567)
+(-0.002784 0.007880 0.221924)
+(-0.005281 -0.005598 0.106993)
+(-0.001707 0.002311 0.187998)
+(0.005996 -0.000767 0.023140)
+(0.008575 -0.005398 0.103451)
+(-0.000641 -0.005702 0.241662)
+(-0.006623 0.004590 0.252277)
+(-0.007006 -0.005918 0.025811)
+(-0.002946 -0.004963 0.027445)
+(-0.003208 -0.006958 0.132322)
+(0.004783 -0.003366 0.204585)
+(-0.006298 0.003616 0.107455)
+(0.003206 0.001955 0.096416)
+(-0.006760 0.004583 0.034448)
+(0.004937 0.001379 0.000239)
+(0.001116 0.002391 0.275649)
+(-0.007738 -0.003638 0.214864)
+(0.006667 0.002753 0.119545)
+(0.004013 -0.007360 0.161851)
+(0.003684 -0.006571 0.115067)
+(0.005958 0.006673 0.018320)
+(-0.006799 -0.005153 0.137816)
+(-0.002845 -0.006651 0.245390)
+(0.004820 -0.006210 0.275224)
+(-0.002634 0.006105 0.250536)
+(0.008199 -0.008372 0.162184)
+(0.008895 -0.002622 0.020106)
+(0.006940 -0.004333 0.226485)
+(0.000733 -0.003797 0.021962)
+(0.008204 -0.007530 0.168940)
+(-0.002956 0.007744 0.034075)
+(-0.001783 0.008059 0.093634)
+(0.006069 0.006829 0.126937)
+(-0.002674 0.001235 0.111208)
+(0.005072 0.007881 0.186765)
+(-0.002062 -0.001684 0.281451)
+(0.003555 0.007615 0.022082)
+(0.004473 0.000304 0.230353)
+(-0.004551 0.008124 0.169829)
+(-0.001552 0.004538 0.020214)
+(-0.006512 0.006469 0.298257)
+(0.005568 0.001159 0.241011)
+(-0.002154 -0.001141 0.166497)
+(-0.004541 -0.008251 0.186716)
+(-0.001279 0.008488 0.284407)
+(-0.004527 -0.009132 0.001586)
+(0.004919 -0.002040 0.143797)
+(-0.005141 0.003930 0.276587)
+(0.001996 -0.008107 0.140642)
+(0.005502 0.006900 0.290885)
+(-0.008823 -0.001374 0.038343)
+(0.003493 -0.002035 0.014168)
+(0.003701 -0.008519 0.146458)
+(0.005713 0.003749 0.251259)
+(0.007248 0.002814 0.104662)
+(-0.007693 0.005385 0.263388)
+(-0.005489 0.001697 0.044944)
+(-0.006811 0.001299 0.014483)
+(-0.006194 -0.008841 0.005169)
+(-0.006052 0.005206 0.150331)
+(-0.007259 0.001258 0.116331)
+(0.008434 -0.001517 0.287566)
+(-0.005758 -0.006326 0.217871)
+(0.008018 -0.006481 0.106844)
+(0.003124 0.006179 0.072483)
+(0.003988 -0.005293 0.174353)
+(0.005997 -0.008679 0.027297)
+(0.004969 -0.001440 0.096029)
+(-0.008399 -0.007068 0.231407)
+(0.007394 0.005349 0.238013)
+(-0.005942 -0.001028 0.166284)
+(0.008061 -0.005547 0.284803)
+(0.006453 -0.001023 0.193863)
+(0.000807 -0.007964 0.130125)
+(0.006669 -0.005858 0.018388)
+(0.007755 0.003564 0.071814)
+(-0.005205 -0.008226 0.269343)
+(-0.001827 0.002625 0.177886)
+(0.007491 -0.002823 0.281987)
+(0.000216 0.006290 0.143345)
+(-0.005304 0.000848 0.052586)
+(0.005464 0.008164 0.199226)
+(-0.006348 -0.008433 0.241201)
+(-0.000361 0.005174 0.119205)
+(0.006249 0.001179 0.182986)
+(0.005454 0.001090 0.183318)
+(0.001237 -0.006604 0.232956)
+(0.005360 -0.003814 0.117896)
+(0.001258 -0.002012 0.161701)
+(0.000383 -0.003981 0.288145)
+(-0.002945 0.005970 0.215650)
+(-0.006387 0.005051 0.245681)
+(-0.006901 0.008059 0.121156)
+(0.000399 -0.000927 0.090034)
+(0.008795 -0.008587 0.234078)
+(-0.000809 0.002061 0.089065)
+(-0.003720 -0.009156 0.114610)
+(-0.001397 -0.006161 0.086711)
+(0.001743 -0.009115 0.116035)
+(0.003500 0.007967 0.039793)
+(0.002583 0.005883 0.128571)
+(-0.004194 -0.007369 0.113820)
+(0.009161 -0.008805 0.255367)
+(-0.007938 0.005347 0.215726)
+(-0.000950 -0.005215 0.105225)
+(0.001736 -0.004851 0.284403)
+(-0.006601 0.000467 0.213414)
+(0.006145 0.001041 0.078424)
+(-0.004596 0.000086 0.031932)
+(-0.002115 -0.008365 0.060795)
+(-0.003822 -0.003394 0.296059)
+(-0.000759 -0.005702 0.276879)
+(0.002469 -0.000371 0.110269)
+(-0.006915 -0.006023 0.005227)
+(0.007186 0.003548 0.075874)
+(0.007665 0.007717 0.052162)
+(-0.002842 -0.007803 0.080869)
+(0.005083 -0.007625 0.101177)
+(-0.002852 0.004038 0.077680)
+(-0.007896 -0.001040 0.103775)
+(0.003317 0.008744 0.212058)
+(0.006445 0.002635 0.094911)
+(-0.008787 0.006532 0.221201)
+(0.002988 -0.002978 0.224443)
+(0.001695 0.008939 0.081529)
+(-0.003532 0.003229 0.014375)
+(0.006430 0.004905 0.196560)
+(0.001546 -0.000639 0.295909)
+(0.004407 0.005485 0.193176)
+(0.004054 -0.006136 0.023926)
+(-0.002953 0.006896 0.200598)
+(-0.003672 -0.002225 0.242950)
+(0.008620 -0.003442 0.073847)
+(0.006455 0.004629 0.102999)
+(-0.008686 -0.002822 0.188864)
+(-0.008006 -0.000454 0.041427)
+(-0.003300 -0.005010 0.237623)
+(-0.002261 0.006035 0.211170)
+(0.000119 -0.009063 0.258460)
+(0.001538 0.007033 0.036564)
+(0.004559 0.001597 0.276096)
+(-0.000272 -0.003983 0.043608)
+(0.003603 0.004210 0.284694)
+(-0.008490 -0.003881 0.299627)
+(-0.007098 0.003927 0.034098)
+(0.000756 0.001048 0.227630)
+(-0.005717 0.003919 0.083278)
+(0.003194 -0.007989 0.200899)
+(-0.002932 0.004053 0.063776)
+(0.000297 0.006455 0.165290)
+(0.002617 -0.008393 0.109932)
+(0.004308 0.005014 0.086677)
+(-0.002826 0.003655 0.280022)
+(-0.002040 0.004407 0.069674)
+(-0.007172 -0.008501 0.047689)
+(-0.008008 -0.000441 0.198763)
+(-0.003011 0.001393 0.244499)
+(0.000661 0.007700 0.241508)
+(0.004140 0.006874 0.289506)
+(0.003862 -0.005117 0.283004)
+(0.001553 -0.009172 0.154732)
+(-0.000318 -0.003340 0.268831)
+(-0.003459 0.000243 0.262167)
+(0.000299 -0.005700 0.178154)
+(-0.005157 0.003049 0.096092)
+(-0.005146 0.007528 0.006762)
+(-0.004333 0.003289 0.047535)
+(-0.004071 0.000208 0.007238)
+(-0.008661 -0.000353 0.279106)
+(0.005904 0.009141 0.190368)
+(0.001042 0.000816 0.116213)
+(0.008990 0.009170 0.054692)
+(-0.007434 -0.002518 0.188513)
+(0.003078 -0.008498 0.112991)
+(-0.000006 -0.002408 0.094198)
+(0.004113 0.002459 0.201935)
+(-0.006148 -0.000478 0.298450)
+(-0.005914 0.007073 0.261911)
+(-0.004152 -0.004370 0.177246)
+(0.001796 0.002657 0.244958)
+(0.003178 -0.007507 0.287083)
+(-0.002383 -0.003342 0.261007)
+(0.001663 0.006366 0.118173)
+(0.005396 -0.004431 0.136459)
+(0.009195 -0.001094 0.267650)
+(-0.000468 -0.005461 0.190482)
+(0.001657 0.001771 0.184060)
+(-0.008848 -0.001394 0.266279)
+(0.006489 0.006441 0.133040)
+(0.000124 0.004846 0.104485)
+(0.005147 0.008040 0.158122)
+(0.006525 -0.001858 0.229669)
+(0.004718 0.000026 0.184235)
+(-0.002702 0.008428 0.190976)
+(0.006835 -0.008718 0.079063)
+(-0.006368 -0.000174 0.041504)
+(-0.007741 0.001548 0.251888)
+(-0.003553 -0.004028 0.261167)
+(-0.000267 -0.000328 0.208608)
+(0.007872 -0.007164 0.019298)
+(-0.003800 0.006749 0.022820)
+(-0.001979 0.000494 0.025555)
+(-0.007556 -0.000200 0.279638)
+(-0.005433 -0.000146 0.154450)
+(0.006877 -0.000664 0.018590)
+(0.003458 -0.006567 0.109099)
+(-0.000222 0.001710 0.132186)
+(-0.002270 0.005477 0.114849)
+(-0.008293 0.009162 0.295607)
+(0.002494 -0.001412 0.140676)
+(-0.000813 0.008532 0.218448)
+(-0.002482 -0.001979 0.119592)
+(-0.008856 0.003718 0.120947)
+(0.005424 0.000954 0.222112)
+(0.007364 -0.004922 0.241365)
+(-0.002543 -0.003983 0.099741)
+(-0.000045 0.007573 0.050798)
+(0.003195 -0.003384 0.069128)
+(0.000663 0.005489 0.258242)
+(-0.006798 0.008540 0.012901)
+(0.008557 0.004219 0.094803)
+(0.003582 0.008074 0.058867)
+(0.005986 -0.003997 0.064199)
+(-0.005168 -0.003983 0.287787)
+(0.006625 0.002507 0.228990)
+(0.001573 -0.002572 0.289562)
+(0.008723 -0.006392 0.008647)
+(0.007258 -0.008624 0.115948)
+(0.001561 0.007470 0.039313)
+(-0.006981 0.001258 0.214312)
+(0.003536 0.000869 0.226691)
+(0.005386 0.001344 0.049406)
+(0.002135 0.008393 0.008302)
+(0.002283 -0.001532 0.178180)
+(-0.002884 0.000488 0.026123)
+(0.005258 0.004071 0.177065)
+(-0.008357 -0.008999 0.292868)
+(-0.007412 -0.008873 0.164572)
+(0.001515 -0.007914 0.199268)
+(-0.003403 -0.008353 0.035104)
+(0.005883 0.008837 0.258135)
+(0.005702 0.008991 0.165115)
+(-0.009133 0.001466 0.041459)
+(-0.000240 0.003458 0.195908)
+(0.005251 -0.006425 0.015691)
+(-0.006180 0.002424 0.080244)
+(0.001310 -0.002302 0.025861)
+(0.001915 -0.004698 0.113357)
+(-0.004336 0.002752 0.093249)
+(-0.002079 -0.004398 0.046159)
+(-0.001230 -0.006248 0.140219)
+(0.002567 -0.002535 0.088363)
+(0.003914 0.008975 0.254517)
+(0.006281 0.004719 0.043312)
+(-0.009127 -0.003206 0.166769)
+(0.006376 -0.000555 0.037835)
+(0.005218 0.002018 0.210700)
+(0.002375 -0.008779 0.286989)
+(-0.002610 0.007271 0.119052)
+(-0.005722 -0.005178 0.217897)
+(-0.003900 -0.000008 0.263426)
+(0.002450 0.000166 0.140796)
+(0.004464 -0.000589 0.189866)
+(0.000996 -0.001331 0.164355)
+(-0.005603 -0.007524 0.077853)
+(-0.003243 -0.000491 0.200676)
+(0.008929 0.009082 0.299972)
+(0.001840 0.000401 0.060858)
+(-0.001334 0.004566 0.239601)
+(-0.005678 -0.008519 0.032433)
+(0.006899 -0.005668 0.008455)
+(0.000266 0.001766 0.104040)
+(-0.008548 -0.000788 0.108301)
+(-0.009037 0.008459 0.072369)
+(0.005754 0.002337 0.296229)
+(-0.004788 0.002764 0.137792)
+(-0.002960 -0.002042 0.290503)
+(-0.006026 0.006155 0.245119)
+(0.004380 -0.004560 0.038071)
+(-0.004351 -0.007313 0.044068)
+(-0.002558 0.004477 0.103618)
+(0.004373 -0.001508 0.288962)
+(-0.002461 -0.001449 0.130682)
+(-0.000458 -0.001536 0.258167)
+(-0.008356 -0.005486 0.002810)
+(-0.001568 -0.002994 0.171753)
+(0.007212 0.002661 0.229427)
+(0.005394 -0.002024 0.214381)
+(0.002602 -0.000590 0.036730)
+(-0.007421 -0.005264 0.210515)
+(-0.007348 0.001154 0.277644)
+(0.004273 0.001874 0.087735)
+(0.007957 0.009011 0.087153)
+(-0.002743 0.006655 0.253524)
+(-0.008653 -0.004114 0.118080)
+(-0.004558 0.000949 0.167946)
+(0.007052 0.006284 0.157871)
+(0.000555 0.000688 0.137877)
+(-0.000883 0.007121 0.276031)
+(-0.004059 -0.005040 0.249162)
+(-0.008150 -0.000918 0.134779)
+(-0.004706 0.004442 0.268006)
+(0.008654 -0.000505 0.123293)
+(0.008978 -0.002497 0.058412)
+(-0.008849 0.003654 0.066510)
+(-0.002044 0.001484 0.010176)
+(-0.008079 -0.007924 0.180107)
+(-0.004204 0.004019 0.267430)
+(0.008296 0.006067 0.214572)
+(-0.002974 -0.002153 0.248889)
+(0.007851 -0.002925 0.079091)
+(-0.006874 0.000037 0.015742)
+(0.004677 -0.000587 0.112563)
+(0.001070 0.007439 0.260132)
+(0.001403 0.004762 0.155872)
+(-0.001256 -0.000137 0.136517)
+(-0.001892 -0.009094 0.134740)
+(-0.006092 0.008566 0.158670)
+(-0.007789 -0.004830 0.164156)
+(0.006807 -0.002838 0.202696)
+(0.003855 0.002166 0.223724)
+(0.006928 0.003546 0.038992)
+(0.003319 0.007506 0.011646)
+(-0.007689 0.003007 0.164621)
+(-0.000904 -0.001270 0.268624)
+(0.008350 0.002999 0.173983)
+(0.002855 0.008775 0.139452)
+(-0.003372 0.006723 0.186854)
+(-0.009114 -0.003156 0.078108)
+(0.007273 0.008719 0.098323)
+(-0.004345 -0.006509 0.277332)
+(0.003299 -0.000585 0.195418)
+(-0.003046 -0.002943 0.282587)
+(-0.005631 -0.007197 0.165098)
+(-0.000244 0.004102 0.076061)
+(0.006333 0.008710 0.025311)
+(0.004761 0.005818 0.186767)
+(-0.006831 -0.003140 0.219718)
+(-0.001803 0.000006 0.228283)
+(-0.000133 -0.002372 0.282115)
+(0.002026 -0.008961 0.130305)
+(0.008289 0.004612 0.083815)
+(0.006360 -0.006515 0.123457)
+(-0.002839 -0.004721 0.010110)
+(0.000280 -0.000987 0.291348)
+(0.007109 0.004112 0.299824)
+(0.006358 -0.002799 0.117858)
+(-0.001661 -0.000213 0.066404)
+(-0.005344 0.007116 0.295349)
+(0.007251 -0.000074 0.151880)
+(0.004469 -0.005298 0.066384)
+(0.001694 -0.003338 0.133426)
+(-0.007155 -0.005915 0.247232)
+(-0.001048 -0.000082 0.162101)
+(-0.006757 0.006089 0.051669)
+(-0.002875 -0.005622 0.269642)
+(0.005941 0.004560 0.095957)
+(-0.003118 0.001523 0.262059)
+(0.007048 -0.001293 0.161691)
+(-0.002097 0.001669 0.250399)
+(0.003645 -0.004512 0.102735)
+(-0.008258 -0.002559 0.189081)
+(-0.005470 0.006561 0.086739)
+(-0.007770 0.002562 0.123556)
+(0.002125 0.004482 0.138034)
+(0.000848 -0.001627 0.208911)
+(-0.006165 -0.008053 0.022835)
+(0.007766 0.008017 0.155444)
+(-0.003052 0.005024 0.188018)
+(-0.001289 -0.006243 0.225077)
+(-0.001759 0.004095 0.043345)
+(-0.008628 0.002081 0.148076)
+(-0.001818 0.001817 0.062289)
+(0.001088 -0.002310 0.183723)
+(0.008575 -0.008269 0.082489)
+(0.002702 -0.003467 0.042511)
+(-0.002890 -0.007319 0.060474)
+(0.000583 0.000432 0.083004)
+(-0.003099 -0.004028 0.261143)
+(0.008566 0.000458 0.231372)
+(0.005848 0.006878 0.104802)
+(0.005777 0.006358 0.233483)
+(0.004862 0.004835 0.042310)
+(-0.004503 -0.005638 0.187396)
+(0.005766 0.006121 0.253422)
+(0.001256 -0.000975 0.085667)
+(-0.000680 0.006971 0.082432)
+(0.003398 -0.006730 0.236822)
+(0.004187 0.008799 0.039691)
+(-0.002163 -0.003480 0.145417)
+(-0.009046 0.003609 0.009420)
+(-0.006938 -0.004819 0.217439)
+(-0.004102 -0.008675 0.094598)
+(-0.008027 -0.006839 0.051996)
+(0.003220 0.002101 0.277834)
+(-0.008293 -0.001292 0.000906)
+(-0.008198 0.002697 0.062433)
+(0.000502 0.004872 0.024255)
+(-0.008401 -0.008126 0.140248)
+(-0.005178 0.000477 0.103257)
+(0.004649 -0.005348 0.057908)
+(-0.004082 0.001422 0.080375)
+(0.001837 -0.007410 0.285220)
+(0.000994 0.004977 0.037356)
+(-0.001134 -0.005150 0.265806)
+(0.003381 0.002714 0.262421)
+(-0.000375 0.006049 0.190208)
+(0.002686 -0.000289 0.248140)
+(0.007262 -0.000309 0.285188)
+(0.002145 0.005628 0.111847)
+(0.008716 -0.001264 0.114669)
+(0.003213 -0.001933 0.202300)
+(-0.005191 0.006878 0.286260)
+(0.000074 0.000515 0.274221)
+(0.001135 0.002658 0.041195)
+(0.002327 -0.005753 0.251330)
+(-0.007145 0.004742 0.133490)
+(-0.007550 -0.000848 0.297406)
+(-0.005797 -0.003388 0.190461)
+(-0.006272 0.003810 0.102452)
+(-0.005146 -0.005368 0.092378)
+(0.005824 0.001284 0.121390)
+(-0.002373 0.004404 0.282682)
+(-0.007437 0.005801 0.261973)
+(-0.006123 0.008135 0.016292)
+(0.001603 0.007985 0.295239)
+(0.005512 -0.002221 0.024499)
+(0.007411 0.007176 0.062209)
+(-0.005765 0.008662 0.241307)
+(-0.003075 -0.008688 0.299275)
+(0.004779 -0.007594 0.266665)
+(0.003921 0.002046 0.273131)
+(0.001836 -0.000219 0.175751)
+(-0.005822 0.005464 0.202748)
+(0.006495 -0.008142 0.035708)
+(0.005286 0.000366 0.161032)
+(-0.008396 -0.001835 0.179670)
+(-0.008943 -0.001020 0.035505)
+(0.005082 -0.004277 0.150753)
+(0.004203 -0.000261 0.062132)
+(0.008289 -0.000317 0.001449)
+(0.005708 0.001450 0.150149)
+(0.008392 0.009112 0.229486)
+(0.002056 -0.006567 0.253049)
+(0.008312 0.004191 0.089053)
+(-0.008317 0.006516 0.276243)
+(-0.004544 0.002572 0.048819)
+(-0.001294 -0.004184 0.161934)
+(-0.001502 -0.004864 0.198966)
+(0.008218 -0.000749 0.254269)
+(-0.001859 -0.001291 0.169937)
+(0.001187 -0.006553 0.102871)
+(-0.007589 0.007871 0.026321)
+(-0.008452 0.006260 0.072151)
+(0.007391 -0.004596 0.044706)
+(-0.003443 -0.005338 0.038602)
+(0.008308 -0.001434 0.127612)
+(-0.003634 0.005921 0.204207)
+(0.007248 0.007875 0.247602)
+(-0.004916 0.005809 0.280654)
+(0.005652 0.000106 0.268728)
+(-0.004745 0.006723 0.169252)
+(-0.000018 0.005128 0.220204)
+(0.002697 -0.003654 0.169328)
+(-0.003244 -0.003765 0.259285)
+(-0.002597 -0.006712 0.187831)
+(0.008732 -0.000862 0.134000)
+(-0.006425 -0.002970 0.220243)
+(-0.008093 -0.008993 0.099652)
+(0.001726 0.001237 0.162698)
+(0.000455 0.002113 0.045917)
+(-0.005924 0.001420 0.134789)
+(-0.001788 0.002917 0.299328)
+(0.004286 0.007895 0.107097)
+(-0.006062 -0.005293 0.241310)
+(-0.007327 -0.008924 0.113655)
+(0.008230 -0.001866 0.292072)
+(-0.007386 -0.004496 0.237881)
+(0.002777 -0.001875 0.229744)
+(0.008452 -0.005520 0.013965)
+(0.008075 -0.004913 0.068855)
+(-0.003484 0.007533 0.221963)
+(-0.000313 0.002558 0.049169)
+(-0.005186 0.003576 0.181279)
+(-0.001302 0.000280 0.205701)
+(0.001782 -0.005371 0.005638)
+(0.004814 0.001856 0.001798)
+(-0.002655 0.003588 0.281894)
+(-0.000593 -0.006129 0.194203)
+(0.005502 0.007008 0.298114)
+(-0.005957 -0.002939 0.127342)
+(-0.005819 -0.002114 0.198018)
+(-0.005823 0.000823 0.211420)
+(0.004323 -0.006635 0.189921)
+(0.004419 0.002110 0.249175)
+(-0.008559 0.008235 0.112971)
+(-0.001102 0.006191 0.188719)
+(-0.008448 0.008966 0.142340)
+(0.008018 -0.000369 0.149396)
+(-0.008970 -0.005099 0.107072)
+(0.006997 0.004824 0.008270)
+(0.001601 -0.000669 0.245536)
+(-0.004163 -0.002875 0.001265)
+(0.000376 -0.005164 0.269421)
+(-0.007604 -0.004515 0.203496)
+(-0.008726 0.005660 0.283361)
+(0.002438 -0.000529 0.119580)
+(0.007862 0.005730 0.274861)
+(-0.001870 0.007189 0.046009)
+(-0.006402 0.007867 0.113946)
+(0.001208 0.002293 0.164137)
+(-0.002477 0.007369 0.052965)
+(0.007163 -0.000641 0.125632)
+(0.003422 0.005697 0.007705)
+(0.008716 -0.002074 0.033959)
+(0.001753 0.001933 0.180905)
+(0.004810 -0.008248 0.060344)
+(0.003019 -0.005342 0.218157)
+(0.006061 0.005955 0.100307)
+(-0.008728 -0.005443 0.250058)
+(-0.005518 -0.006232 0.069015)
+(-0.000887 -0.002242 0.100829)
+(-0.002400 0.001834 0.164814)
+(-0.005393 -0.001296 0.195540)
+(-0.008040 0.008402 0.063431)
+(0.005898 0.000362 0.064083)
+(0.003920 -0.001152 0.290233)
+(0.006866 -0.000702 0.105056)
+(0.001526 -0.003052 0.059192)
+(-0.006485 0.004080 0.248297)
+(0.004991 -0.003550 0.023557)
+(-0.008585 -0.002497 0.098629)
+(-0.003901 -0.005570 0.029738)
+(0.004550 -0.002079 0.246399)
+(-0.008969 -0.004547 0.083947)
+(0.004181 0.007011 0.038355)
+(-0.004494 0.005084 0.029352)
+(-0.007977 0.003721 0.104748)
+(0.001369 -0.005585 0.044323)
+(0.005825 -0.009091 0.296373)
+(-0.008866 -0.005952 0.180945)
+(-0.005581 -0.004104 0.190093)
+(-0.006461 0.001533 0.036777)
+(0.007030 0.008740 0.122173)
+(-0.006086 0.008573 0.081075)
+(-0.008460 -0.003271 0.288724)
+(0.000359 -0.001766 0.110639)
+(0.004407 0.004322 0.294231)
+(0.001359 -0.005522 0.146572)
+(0.005152 0.001283 0.021923)
+(-0.003732 0.003819 0.005185)
+(-0.007406 0.001052 0.075210)
+(-0.005148 -0.003638 0.153206)
+(-0.003143 -0.002405 0.091218)
+(0.002997 -0.006589 0.169086)
+(-0.008786 0.003116 0.026972)
+(-0.005333 0.007343 0.066434)
+(0.004585 0.005908 0.290996)
+(-0.005354 -0.000687 0.169168)
+(0.002917 0.004073 0.154800)
+(0.008715 -0.004013 0.182763)
+(0.001462 -0.003612 0.001046)
+(0.007906 -0.006204 0.258254)
+(0.007076 -0.008262 0.132959)
+(-0.004012 0.007365 0.211800)
+(-0.000860 0.002601 0.117150)
+(0.004978 0.007811 0.288481)
+(-0.002728 -0.005333 0.206950)
+(0.004554 -0.008632 0.134891)
+(0.003854 0.008566 0.237332)
+(-0.005397 -0.003010 0.218415)
+(-0.005381 -0.004832 0.022885)
+(0.008578 0.005840 0.262318)
+(-0.006199 -0.008551 0.205938)
+(-0.006386 -0.006184 0.024195)
+(-0.007805 -0.003504 0.158744)
+(-0.002668 -0.008752 0.263351)
+(0.001538 -0.000319 0.293092)
+(0.002851 0.008077 0.122923)
+(0.006822 -0.005103 0.240231)
+(0.000456 -0.001171 0.223716)
+(0.007670 -0.001414 0.212965)
+(0.007766 -0.004112 0.267651)
+(0.006547 0.002553 0.148244)
+(-0.003927 -0.005266 0.186326)
+(-0.004603 0.007558 0.227769)
+(-0.006469 0.007795 0.294561)
+(0.002227 -0.006248 0.236547)
+(-0.004468 -0.003801 0.287020)
+(0.008887 -0.005046 0.236607)
+(-0.000645 -0.004263 0.131496)
+(0.003216 -0.006092 0.191340)
+(0.000153 0.009165 0.162341)
+(0.006875 0.004234 0.295840)
+(-0.003721 -0.001446 0.221969)
+(-0.002185 0.007154 0.287475)
+(-0.003411 -0.004168 0.145066)
+(-0.007036 0.002718 0.150027)
+(0.006358 0.003002 0.216706)
+(0.000740 -0.007344 0.151816)
+(0.004961 -0.006020 0.095141)
+(0.006953 -0.008434 0.256514)
+(0.008591 0.002150 0.210166)
+(0.001040 -0.008399 0.295624)
+(-0.006088 -0.002175 0.023000)
+(-0.002984 0.008785 0.226742)
+(-0.003685 -0.000372 0.268917)
+(-0.006812 0.006283 0.086566)
+(-0.003262 0.006359 0.279417)
+(0.008844 -0.005015 0.040832)
+(-0.007882 0.002095 0.040396)
+(-0.007073 -0.005240 0.040338)
+(-0.004336 0.000486 0.118740)
+(0.004986 -0.001470 0.234551)
+(0.004112 0.007442 0.132232)
+(-0.000106 -0.002610 0.135610)
+(0.001452 -0.000417 0.141864)
+(-0.004672 0.000017 0.072926)
+(0.003007 0.001885 0.026710)
+(0.007303 -0.001060 0.265824)
+(0.000744 -0.008470 0.288073)
+(-0.000204 -0.002512 0.196909)
+(-0.006803 -0.004229 0.288957)
+(0.001244 -0.007227 0.180743)
+(0.008983 0.003316 0.197985)
+(0.004627 0.004401 0.172544)
+(-0.003080 0.000167 0.284169)
+(-0.005263 0.002654 0.133036)
+(-0.008276 0.003719 0.005153)
+(-0.002157 0.008724 0.250547)
+(0.004598 0.000251 0.033627)
+(0.000144 -0.003666 0.052465)
+(0.002249 -0.002860 0.178588)
+(-0.005906 0.002639 0.082684)
+(0.005623 -0.001517 0.185799)
+(-0.008222 0.006104 0.228694)
+(0.001083 -0.003540 0.221067)
+(-0.003214 -0.002211 0.084470)
+(-0.003661 0.005649 0.026397)
+(0.001227 -0.006157 0.052156)
+(0.008846 0.001211 0.260321)
+(0.008076 -0.005157 0.043978)
+(-0.003484 -0.007579 0.164118)
+(-0.003177 -0.007766 0.148383)
+(0.005275 0.001081 0.066659)
+(-0.007748 -0.008379 0.079876)
+(0.002252 -0.005394 0.285894)
+(-0.004834 -0.006071 0.217034)
+(0.000201 0.005272 0.278028)
+(0.002874 0.009124 0.277035)
+(0.003521 -0.005995 0.060511)
+(0.008024 -0.002835 0.074981)
+(-0.001608 0.002498 0.116931)
+(-0.002028 -0.007970 0.124913)
+(0.008718 -0.005639 0.016251)
+(0.002284 -0.002399 0.258667)
+(-0.000026 0.008564 0.253052)
+(-0.000641 0.007766 0.165959)
+(0.001016 0.008152 0.021004)
+(0.007453 0.001542 0.154157)
+(0.001414 0.007875 0.210668)
+(-0.007933 0.001170 0.087244)
+(0.002446 0.005947 0.048123)
+(0.008986 0.005926 0.031192)
+(-0.004070 0.000776 0.285183)
+(-0.001825 -0.007245 0.050014)
+(0.003422 0.007337 0.245618)
+(-0.002198 -0.002749 0.001217)
+(-0.008299 -0.005986 0.136151)
+(-0.008033 0.000136 0.008720)
+(-0.004735 0.000100 0.209773)
+(0.003368 0.002943 0.011522)
+(0.008403 -0.003084 0.134505)
+(0.003972 0.005365 0.156694)
+(0.000804 0.005166 0.190614)
+(0.002000 0.002666 0.226975)
+(-0.004264 -0.006691 0.204672)
+(-0.001379 0.001986 0.049020)
+(-0.005257 -0.002120 0.295921)
+(0.000085 -0.008205 0.073820)
+(0.005730 -0.005992 0.215894)
+(-0.002443 -0.008025 0.295664)
+(-0.004209 -0.002593 0.051467)
+(-0.000381 0.003634 0.041048)
+(0.005893 0.006309 0.059159)
+(-0.000225 -0.002343 0.011528)
+(0.003820 -0.001116 0.299868)
+(0.006521 -0.007859 0.026911)
+(-0.006427 -0.006564 0.182243)
+(0.007235 -0.005903 0.269799)
+(0.004502 -0.006466 0.221896)
+(-0.007332 0.002584 0.262670)
+(0.004620 -0.004602 0.022725)
+(0.006693 0.006636 0.191178)
+(0.007950 -0.000227 0.053485)
+(0.006885 -0.000399 0.139890)
+(-0.008001 0.000549 0.136013)
+(0.007254 0.008611 0.263427)
+(0.000360 -0.003150 0.237900)
+(0.002258 -0.007067 0.146787)
+(-0.001319 0.006329 0.207651)
+(0.005231 0.003857 0.084973)
+(0.008460 -0.002692 0.108678)
+(-0.003817 0.002306 0.154076)
+(-0.005946 -0.008915 0.161044)
+(0.009172 0.004388 0.154681)
+(-0.001129 -0.001807 0.022132)
+(0.006442 0.002085 0.098933)
+(0.004544 -0.001604 0.198193)
+(-0.007443 -0.000109 0.110835)
+(0.005782 -0.007212 0.126529)
+(-0.008697 0.005680 0.021434)
+(0.007632 -0.009099 0.012411)
+(-0.003791 -0.006894 0.134933)
+(0.007809 -0.000721 0.126246)
+(-0.004355 0.002608 0.191242)
+(0.006429 -0.000655 0.261566)
+(-0.002258 0.008353 0.261687)
+(-0.004945 -0.006044 0.258930)
+(-0.000960 -0.002222 0.230926)
+(0.004825 -0.004763 0.028402)
+(0.005337 0.002615 0.127592)
+(0.003828 0.008165 0.295398)
+(0.003799 0.006263 0.015464)
+(-0.007965 0.004554 0.087384)
+(-0.008033 -0.002743 0.290158)
+(-0.001485 0.005079 0.179050)
+(0.003936 -0.001113 0.189933)
+(-0.008773 -0.005012 0.212199)
+(0.000100 -0.005426 0.250775)
+(-0.004276 -0.003704 0.258222)
+(0.008006 0.003825 0.202925)
+(0.008353 0.008704 0.165134)
+(0.001801 -0.001677 0.058302)
+(-0.004136 -0.007513 0.215308)
+(0.003639 0.006157 0.296312)
+(0.002947 0.000260 0.079019)
+(0.001807 0.003332 0.181459)
+(0.007264 -0.006921 0.141564)
+(-0.001765 -0.006292 0.291681)
+(0.007588 -0.002514 0.188277)
+(0.001562 0.002196 0.009131)
+(0.007409 -0.006615 0.291957)
+(-0.008711 0.000007 0.123247)
+(0.000522 -0.009119 0.200852)
+(-0.004617 -0.003600 0.002187)
+(-0.005618 -0.003372 0.010523)
+(-0.000280 -0.007578 0.083939)
+(-0.002382 -0.007722 0.071201)
+(0.004146 -0.004963 0.134593)
+(-0.008223 0.005524 0.261247)
+(-0.002462 -0.001789 0.113173)
+(0.000647 -0.001694 0.011466)
+(-0.000928 0.003647 0.209999)
+(-0.008760 0.008764 0.099186)
+(0.001415 0.008370 0.186166)
+(-0.000797 -0.002730 0.171468)
+(0.007550 0.008407 0.140930)
+(0.006818 0.001862 0.239286)
+(0.000403 -0.008141 0.034352)
+(-0.006764 -0.000594 0.204896)
+(-0.002856 0.004852 0.166464)
+(-0.007599 0.000115 0.008262)
+(0.003620 0.001517 0.248494)
+(0.000374 0.006752 0.277180)
+(0.004059 0.001162 0.113880)
+(0.002978 0.008133 0.048995)
+(0.006783 0.002280 0.018223)
+(0.000436 0.005678 0.267803)
+(0.001223 0.003559 0.273664)
+(-0.001436 -0.008146 0.255409)
+(0.002527 -0.007143 0.196627)
+(0.004448 -0.002678 0.033254)
+(-0.003382 -0.005072 0.173734)
+(-0.008486 -0.001031 0.088633)
+(0.005325 0.006272 0.232528)
+(0.000006 -0.008538 0.130314)
+(0.007845 0.005012 0.285098)
+(0.007114 0.006587 0.038557)
+(0.004247 -0.006995 0.103556)
+(0.003953 -0.001100 0.101310)
+(-0.006554 -0.000524 0.235556)
+(0.008956 0.004481 0.023959)
+(-0.008291 -0.003410 0.187971)
+(-0.005664 -0.008127 0.126351)
+(0.002781 0.004689 0.288874)
+(0.000592 0.001317 0.069637)
+(0.002625 -0.001546 0.123297)
+(-0.001507 -0.006804 0.294382)
+(-0.001014 -0.003494 0.250809)
+(0.003297 0.004660 0.137746)
+(-0.004209 0.003558 0.299703)
+(-0.005544 0.003357 0.065762)
+(-0.007163 -0.003754 0.131766)
+(0.006844 0.000856 0.248449)
+(-0.007726 0.001564 0.142503)
+(0.006672 -0.001264 0.109110)
+(0.007229 0.008824 0.024112)
+(-0.004385 0.004833 0.136100)
+(0.008120 0.002950 0.042687)
+(-0.007783 -0.008232 0.035622)
+(-0.000576 0.008276 0.274035)
+(-0.002593 0.007537 0.284741)
+(0.005945 0.007814 0.174365)
+(-0.000364 0.007770 0.004249)
+(0.000051 -0.007006 0.098195)
+(-0.000676 0.005136 0.114395)
+(-0.004314 -0.008852 0.175621)
+(0.007871 0.007826 0.147629)
+(-0.007142 -0.002608 0.117630)
+(-0.006327 -0.001196 0.044851)
+(-0.007207 -0.003565 0.198662)
+(-0.008938 0.004310 0.068880)
+(0.005082 0.007690 0.212105)
+(-0.004558 0.003108 0.081045)
+(-0.003180 -0.008636 0.232382)
+(0.005839 -0.008273 0.062764)
+(0.000083 -0.004865 0.041584)
+(-0.002194 -0.008369 0.262323)
+(0.008723 -0.008676 0.143374)
+(0.007752 -0.008684 0.089520)
+(-0.008984 0.008166 0.082829)
+(-0.004186 0.001183 0.293006)
+(-0.004591 0.000170 0.032887)
+(0.008190 -0.005253 0.025119)
+(0.003613 -0.004292 0.255975)
+(-0.003314 -0.005329 0.060891)
+(0.004237 -0.002680 0.175040)
+(0.005001 0.003432 0.155872)
+(-0.005955 -0.000735 0.290069)
+(0.007068 0.008327 0.038657)
+(0.003038 0.007931 0.067999)
+(-0.001208 0.005399 0.158168)
+(-0.006067 0.005692 0.098493)
+(-0.007792 0.003147 0.244102)
+(-0.008606 -0.004485 0.016221)
+(-0.003497 -0.007491 0.183941)
+(-0.008513 0.001738 0.218292)
+(-0.007515 0.005948 0.166038)
+(0.006436 0.007462 0.015386)
+(-0.003180 0.000466 0.275841)
+(-0.004151 -0.005995 0.148542)
+(0.004975 0.006087 0.292379)
+(0.005822 -0.009002 0.044878)
+(0.001792 0.001800 0.298964)
+(0.002684 -0.008845 0.033023)
+(-0.004885 0.000591 0.200800)
+(-0.001135 -0.006028 0.167379)
+(0.008029 0.006159 0.208751)
+(-0.001119 -0.001227 0.184164)
+(0.006957 0.002380 0.099516)
+(0.002779 -0.002848 0.008029)
+(0.000914 0.007094 0.046856)
+(0.002683 -0.000029 0.140299)
+(-0.007226 0.007177 0.204676)
+(-0.003497 -0.007719 0.268005)
+(-0.004182 0.001404 0.012576)
+(-0.003324 0.006725 0.151732)
+(-0.003665 -0.007481 0.150313)
+(0.004791 0.006805 0.056546)
+(-0.003624 -0.005466 0.115595)
+(0.001247 -0.007402 0.064421)
+(0.002907 0.000160 0.038444)
+(-0.004002 -0.008750 0.256490)
+(-0.004981 0.003243 0.070200)
+(-0.000172 -0.002591 0.022375)
+(-0.008831 -0.000559 0.050043)
+(-0.006585 0.000652 0.085903)
+(0.002774 -0.003193 0.146165)
+(-0.005619 -0.007462 0.067135)
+(-0.005292 -0.004617 0.032689)
+(0.003477 -0.004095 0.182022)
+(0.007557 0.001989 0.176223)
+(-0.007637 0.004726 0.142960)
+(0.002619 -0.002172 0.140395)
+(-0.007981 0.002278 0.011910)
+(-0.003014 -0.005525 0.093884)
+(-0.006964 -0.008651 0.131559)
+(-0.002943 -0.007029 0.225635)
+(0.005619 -0.006675 0.032451)
+(0.001741 0.005212 0.286678)
+(0.001017 0.004219 0.101035)
+(0.006997 0.004204 0.106854)
+(0.006656 -0.001933 0.075844)
+(-0.002356 0.007132 0.084004)
+(-0.008322 -0.006270 0.024177)
+(0.006082 -0.002675 0.244241)
+(0.009121 0.002207 0.033770)
+(0.008425 0.005823 0.295817)
+(0.005151 -0.001105 0.212661)
+(0.006030 0.008985 0.123933)
+(0.008019 -0.006942 0.245596)
+(-0.008370 0.004352 0.270839)
+(0.006783 0.008434 0.215758)
+(-0.007996 0.003019 0.120604)
+(-0.004766 0.001929 0.278965)
+(0.000555 -0.003646 0.196667)
+(0.002970 -0.005707 0.015146)
+(0.002990 0.001334 0.151245)
+(0.004789 0.000812 0.231988)
+(0.003502 0.006716 0.254530)
+(-0.001294 -0.003035 0.254737)
+(0.005588 0.006911 0.062281)
+(0.007061 -0.000553 0.053803)
+(-0.008741 0.003728 0.022623)
+(-0.006298 -0.000051 0.069345)
+(0.007946 -0.000161 0.197077)
+(0.007546 -0.001241 0.251330)
+(-0.008239 0.004546 0.024626)
+(-0.000886 -0.006710 0.047453)
+(0.006426 0.006864 0.118003)
+(0.001904 0.003296 0.006092)
+(-0.005772 -0.000297 0.094536)
+(0.007028 0.000530 0.287884)
+(-0.003547 0.002408 0.181555)
+(-0.006170 -0.000105 0.215822)
+(0.000334 0.001267 0.030361)
+(0.006496 0.005197 0.158178)
+(-0.004829 -0.006233 0.064944)
+(-0.000275 0.008420 0.133691)
+(-0.007864 0.006094 0.034639)
+(0.008169 0.001804 0.022718)
+(0.001801 -0.004522 0.116986)
+(0.006611 -0.004190 0.237304)
+(0.006164 -0.006229 0.060610)
+(0.004319 0.006923 0.003152)
+(-0.007556 0.003758 0.287521)
+(0.001321 -0.000077 0.067788)
+(0.003866 0.005302 0.256552)
+(0.006803 0.008572 0.084306)
+(0.001349 -0.001751 0.121822)
+(0.001738 0.007365 0.083761)
+(0.000732 0.008575 0.290688)
+(-0.000009 0.001702 0.100671)
+(-0.004943 -0.000709 0.083906)
+(0.003865 0.001756 0.200061)
+(-0.000618 0.006425 0.281028)
+(0.002091 -0.005628 0.093919)
+(0.008690 -0.002881 0.169289)
+(0.001736 -0.004768 0.066426)
+(0.000358 -0.000260 0.069406)
+(0.009015 -0.001831 0.090368)
+(-0.002899 -0.000571 0.177217)
+(0.007499 -0.001910 0.291621)
+(-0.002738 -0.009083 0.179314)
+(0.005415 0.006813 0.046641)
+(0.006980 0.006351 0.000993)
+(-0.005314 0.006365 0.025561)
+(0.004625 0.005247 0.270703)
+(0.000238 0.001892 0.012370)
+(-0.000268 0.004178 0.196109)
+(0.004040 -0.005674 0.263064)
+(0.002219 0.008927 0.033556)
+(0.006772 -0.004915 0.030088)
+(0.004580 0.007841 0.134478)
+(-0.002179 0.006881 0.120864)
+(0.006205 0.009148 0.070407)
+(-0.002049 0.002573 0.044821)
+(0.009072 -0.006189 0.187292)
+(0.002795 -0.008285 0.103376)
+(0.003963 -0.000680 0.081993)
+(0.004738 0.007185 0.225237)
+(-0.000799 -0.002288 0.258026)
+(-0.008148 -0.001094 0.163707)
+(-0.002296 0.001212 0.278243)
+(-0.003665 -0.001865 0.112172)
+(0.001872 -0.001370 0.210947)
+(-0.000758 -0.007409 0.275808)
+(-0.008012 0.000853 0.257120)
+(-0.000303 -0.008003 0.188363)
+(-0.000413 0.002384 0.048697)
+(-0.006263 -0.002640 0.124828)
+(0.009166 0.000327 0.047627)
+(0.007888 0.002981 0.239716)
+(-0.004660 -0.000834 0.190625)
+(0.006848 -0.008200 0.056512)
+(-0.004610 -0.002308 0.239927)
+(-0.004116 -0.007967 0.028926)
+(0.007573 -0.002902 0.183069)
+(0.002508 0.000906 0.147411)
+(-0.007142 0.002601 0.159563)
+(0.004401 0.006437 0.177244)
+(0.000787 0.006578 0.228580)
+(-0.001334 -0.009004 0.076091)
+(0.008161 0.005637 0.282372)
+(0.004500 -0.001321 0.199922)
+(-0.003975 0.005986 0.107590)
+(0.002302 0.000268 0.051749)
+(-0.000098 -0.002717 0.164570)
+(0.005140 -0.006890 0.045428)
+(0.004847 0.004250 0.236045)
+(0.004299 -0.003123 0.141240)
+(-0.001095 0.003912 0.131584)
+(0.001472 -0.004563 0.259577)
+(-0.005956 0.002504 0.063466)
+(0.007247 0.004972 0.197161)
+(0.007295 -0.005585 0.187923)
+(0.003589 -0.001288 0.295837)
+(0.008594 -0.005559 0.092718)
+(0.000406 0.007204 0.240252)
+(0.004770 -0.000130 0.207316)
+(-0.006233 -0.000299 0.069865)
+(-0.004792 -0.005001 0.076803)
+(-0.007855 -0.006741 0.071716)
+(0.003168 -0.000822 0.061260)
+(-0.004841 0.008560 0.159117)
+(0.004417 0.005388 0.224646)
+(0.003116 0.004408 0.164518)
+(-0.000458 -0.007587 0.059407)
+(0.009185 0.000594 0.100682)
+(0.006578 -0.008010 0.250204)
+(0.001149 -0.006958 0.279952)
+(0.002429 0.002362 0.296445)
+(-0.002124 -0.006701 0.279465)
+(-0.007198 0.001814 0.290274)
+(-0.002820 0.004752 0.256143)
+(-0.001937 -0.001996 0.242288)
+(-0.002779 0.004160 0.154499)
+(0.006674 -0.008563 0.264132)
+(-0.001875 0.003210 0.032283)
+(0.006133 -0.002788 0.199892)
+(-0.000769 -0.006472 0.066095)
+(-0.008577 -0.006354 0.264522)
+(-0.002408 0.001259 0.158435)
+)
+
+/ ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/column/constant/kinematicCloudProperties b/tutorials/lagrangian/MPPICFoam/column/constant/kinematicCloudProperties
new file mode 100644
index 0000000000000000000000000000000000000000..5f2d7b67bf5fa692b2a9d6f8012493d10fd155d3
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/column/constant/kinematicCloudProperties
@@ -0,0 +1,188 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      particleProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+solution
+{
+    active          true;
+    coupled         true;
+    transient       yes;
+    cellValueSourceCorrection off;
+
+    interpolationSchemes
+    {
+        rho.air         cell;
+        U.air           cellPoint;
+        mu.air          cell;
+    }
+
+    averagingMethod dual;
+
+    integrationSchemes
+    {
+        U               Euler;
+    }
+
+    sourceTerms
+    {
+        schemes
+        {
+            U     semiImplicit 1;
+        }
+    }
+}
+
+constantProperties
+{
+    rho0            2526;
+    alphaMax        0.9;
+}
+
+subModels
+{
+    particleForces
+    {
+        ErgunWenYuDrag
+        {
+            alphac alpha.air;
+        }
+        //gravity;
+    }
+
+    injectionModels
+    {
+        model1
+        {
+            type            manualInjection;
+            massTotal       0;
+            parcelBasisType fixed;
+            nParticle       750;
+            SOI             0;
+            positionsFile   "kinematicCloudPositions";
+            U0              ( 0 0 0 );
+            sizeDistribution
+            {
+                type        fixedValue;
+                fixedValueDistribution
+                {
+                    value   0.0003;
+                }
+            }
+        }
+    }
+
+    dispersionModel none;
+
+    patchInteractionModel localInteraction;
+
+    localInteractionCoeffs
+    {
+        patches
+        (
+            sides
+            {
+                type rebound;
+                e    1;
+                mu   0;
+            }
+            top
+            {
+                type rebound;
+                e    1;
+                mu   0;
+            }
+            bottom
+            {
+                type rebound;
+                e    1;
+                mu   0;
+            }
+        );
+    }
+
+    heatTransferModel none;
+
+    surfaceFilmModel none;
+
+    packingModel implicit;
+
+    explicitCoeffs
+    {
+        particleStressModel
+        {
+            type HarrisCrighton;
+            alphaPacked 0.6;
+            pSolid 10.0;
+            beta 2.0;
+            eps 1.0e-7;
+        }
+        correctionLimitingMethod
+        {
+            type absolute;
+            e 0.9;
+        }
+    }
+
+    implicitCoeffs
+    {
+        alphaMin 0.0001;
+        rhoMin 1.0;
+        applyGravity true;
+        particleStressModel
+        {
+            type HarrisCrighton;
+            alphaPacked 0.6;
+            pSolid 10.0;
+            beta 2.0;
+            eps 1.0e-2;
+        }
+    }
+
+    dampingModel none; //relaxation;
+
+    relaxationCoeffs
+    {
+        timeScaleModel
+        {
+            type nonEquilibrium;
+            alphaPacked 0.6;
+            e 0.9;
+        }
+    }
+
+    isotropyModel stochastic;
+
+    stochasticCoeffs
+    {
+        timeScaleModel
+        {
+            type isotropic;
+            alphaPacked 0.6;
+            e 0.9;
+        }
+    }
+
+    stochasticCollisionModel none;
+
+    radiation off;
+}
+
+
+cloudFunctions
+{}
+
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/column/constant/polyMesh/blockMeshDict b/tutorials/lagrangian/MPPICFoam/column/constant/polyMesh/blockMeshDict
new file mode 100644
index 0000000000000000000000000000000000000000..c5cbc4272bfb36a7d70a820c2106b81e7b2de831
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/column/constant/polyMesh/blockMeshDict
@@ -0,0 +1,73 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    object      blockMeshDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+convertToMeters 0.001;
+
+vertices
+(
+    (-9.2 -9.2   0)
+    ( 9.2 -9.2   0)
+    ( 9.2  9.2   0)
+    (-9.2  9.2   0)
+    (-9.2 -9.2 300)
+    ( 9.2 -9.2 300)
+    ( 9.2  9.2 300)
+    (-9.2  9.2 300)
+);
+
+blocks
+(
+    hex (0 1 2 3 4 5 6 7) (1 1 40) simpleGrading (1 1 1)
+);
+
+edges
+(
+);
+
+boundary
+(
+    sides
+    {
+        type symmetry;
+        faces
+        (
+            (0 1 5 4)
+            (1 2 6 5)
+            (2 3 7 6)
+            (3 0 4 7)
+        );
+    }
+
+    top
+    {
+        type wall;
+        faces
+        (
+            (4 5 6 7)
+        );
+    }
+
+    bottom
+    {
+        type wall;
+        faces
+        (
+            (0 1 2 3)
+        );
+    }
+);
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/column/constant/transportProperties b/tutorials/lagrangian/MPPICFoam/column/constant/transportProperties
new file mode 100644
index 0000000000000000000000000000000000000000..4d91af2fb3827a82afbf628abd3db0b9332d2183
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/column/constant/transportProperties
@@ -0,0 +1,25 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      transportProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+contiuousPhaseName air;
+
+rho.air         1.2;
+
+transportModel  Newtonian;
+nu              1e-05;
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/column/constant/turbulenceProperties.air b/tutorials/lagrangian/MPPICFoam/column/constant/turbulenceProperties.air
new file mode 100644
index 0000000000000000000000000000000000000000..1296429b72a21953def920b08774aa75e1d048b1
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/column/constant/turbulenceProperties.air
@@ -0,0 +1,20 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      turbulenceProperties.air;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+simulationType  laminar;
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/column/system/controlDict b/tutorials/lagrangian/MPPICFoam/column/system/controlDict
new file mode 100644
index 0000000000000000000000000000000000000000..e4337f65679891939f3cfb93353e71c22a0d7926
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/column/system/controlDict
@@ -0,0 +1,48 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "system";
+    object      controlDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+application     MPPICFoam;
+
+startFrom       startTime;
+
+startTime       0;
+
+stopAt          endTime;
+
+endTime         1;
+
+deltaT          2e-4;
+
+writeControl    runTime;
+
+writeInterval   0.01;
+
+purgeWrite      0;
+
+writeFormat     ascii;
+
+writePrecision  8;
+
+writeCompression uncompressed;
+
+timeFormat      general;
+
+timePrecision   6;
+
+runTimeModifiable yes;
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/column/system/fvSchemes b/tutorials/lagrangian/MPPICFoam/column/system/fvSchemes
new file mode 100644
index 0000000000000000000000000000000000000000..d95ec2edb6510abf20228ebc3ce633f4415d9825
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/column/system/fvSchemes
@@ -0,0 +1,64 @@
+/*--------------------------------*- 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      fvSchemes;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+ddtSchemes
+{
+    default Euler;
+}
+
+d2dt2Schemes
+{
+    default Euler;
+}
+
+gradSchemes
+{
+    default         Gauss linear;
+}
+
+divSchemes
+{
+    default         none;
+
+    div(alphaPhic,U.air)    Gauss linearUpwindV unlimited;
+    div(((alpha.air*nuEff)*dev2(T(grad(U.air))))) Gauss linear;
+
+    div(phiGByA,kinematicCloud:alpha) Gauss linear;
+}
+
+laplacianSchemes
+{
+    default         Gauss linear corrected;
+}
+
+interpolationSchemes
+{
+    default         linear;
+}
+
+snGradSchemes
+{
+    default         corrected;
+}
+
+fluxRequired
+{
+    default         no;
+    p;
+    kinematicCloud:alpha;
+}
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/column/system/fvSolution b/tutorials/lagrangian/MPPICFoam/column/system/fvSolution
new file mode 100644
index 0000000000000000000000000000000000000000..d52e9d19e98593f5707d0dc44d8b89e87910a005
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/column/system/fvSolution
@@ -0,0 +1,74 @@
+/*--------------------------------*- 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-06;
+        relTol          0.01;
+    }
+
+    pFinal
+    {
+        $p;
+        relTol          0;
+    }
+
+    U.air
+    {
+        solver          PBiCG;
+        preconditioner  DILU;
+        tolerance       1e-05;
+        relTol          0.1;
+    }
+
+    U.airFinal
+    {
+        solver          PBiCG;
+        preconditioner  DILU;
+        tolerance       1e-05;
+        relTol          0;
+    }
+
+    kinematicCloud:alpha
+    {
+        solver          PBiCG;
+        preconditioner  DILU;
+        tolerance       1e-06;
+        relTol          0;
+    }
+}
+
+PIMPLE
+{
+    nOuterCorrectors 1;
+    nCorrectors     2;
+    momentumPredictor yes;
+    nNonOrthogonalCorrectors 0;
+    pRefCell        0;
+    pRefValue       0;
+}
+
+relaxationFactors
+{
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/injectionChannel/0/U.air b/tutorials/lagrangian/MPPICFoam/injectionChannel/0/U.air
new file mode 100644
index 0000000000000000000000000000000000000000..08270dfd69ef8a81a7ed96e8517f641575720f8e
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/injectionChannel/0/U.air
@@ -0,0 +1,57 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      binary;
+    class       volVectorField;
+    location    "0";
+    object      U;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 1 -1 0 0 0 0];
+
+internalField   uniform (0 0 0);
+
+boundaryField
+{
+    walls
+    {
+        type            fixedValue;
+        value           uniform (0 0 0);
+    }
+
+    lowerInlet
+    {
+        type            fixedValue;
+        value           uniform (18.7939 6.8404 0);
+    }
+
+    upperInlet
+    {
+        type            fixedValue;
+        value           uniform (18.7939 6.8404 0);
+    }
+
+    outlet
+    {
+        type            inletOutlet;
+        phi             phi.air;
+        inletValue      uniform (0 0 0);
+        value           uniform (0 0 0);
+    }
+
+    frontAndBack
+    {
+        type            symmetry;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/injectionChannel/0/p b/tutorials/lagrangian/MPPICFoam/injectionChannel/0/p
new file mode 100644
index 0000000000000000000000000000000000000000..b0c410f374fd05ea140a260f98fdcf1771718522
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/injectionChannel/0/p
@@ -0,0 +1,57 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       volScalarField;
+    object      p;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 2 -2 0 0 0 0];
+
+internalField   uniform 0;
+
+boundaryField
+{
+    walls
+    {
+        type            fixedFluxPressure;
+        phi             phi.air;
+        value           $internalField;
+    }
+
+    lowerInlet
+    {
+        type            fixedFluxPressure;
+        phi             phi.air;
+        value           $internalField;
+    }
+
+    upperInlet
+    {
+        type            fixedFluxPressure;
+        phi             phi.air;
+        value           $internalField;
+    }
+
+    outlet
+    {
+        type            fixedValue;
+        phi             phi.air;
+        value           uniform 0;
+    }
+
+    frontAndBack        
+    {
+        type            symmetry;
+    }
+}
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/injectionChannel/constant/g b/tutorials/lagrangian/MPPICFoam/injectionChannel/constant/g
new file mode 100644
index 0000000000000000000000000000000000000000..057403310a4dba8dc69f1470dd26d8a7d6d6b978
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/injectionChannel/constant/g
@@ -0,0 +1,22 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       uniformDimensionedVectorField;
+    location    "constant";
+    object      g;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 1 -2 0 0 0 0];
+value           ( 0 0 0 );
+
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/injectionChannel/constant/kinematicCloudProperties b/tutorials/lagrangian/MPPICFoam/injectionChannel/constant/kinematicCloudProperties
new file mode 100644
index 0000000000000000000000000000000000000000..0055095d8e4f1f886e282695b4d6d0912c355537
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/injectionChannel/constant/kinematicCloudProperties
@@ -0,0 +1,193 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      particleProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+solution
+{
+    active          true;
+    coupled         true;
+    transient       yes;
+    cellValueSourceCorrection on;
+
+    interpolationSchemes
+    {
+        rho.air         cell;
+        U.air           cellPoint;
+        mu.air          cell;
+    }
+
+    averagingMethod basic;
+
+    integrationSchemes
+    {
+        U               Euler;
+    }
+
+    sourceTerms
+    {
+        schemes
+        {
+            U semiImplicit 1;
+        }
+    }
+}
+
+constantProperties
+{
+    rho0            1000;
+
+    alphaMax        0.9;
+}
+
+subModels
+{
+    particleForces
+    {
+        WenYuDrag
+        {
+            alphac alpha.air;
+        }
+    }
+
+    injectionModels
+    {
+        /*
+            % matlab/octave calculation of flow rate
+            alpha=0.1
+            U=20
+            A=0.01^2
+            Q=U*A
+            d=650e-6
+            v=(4/3)*pi*(d/2)^3
+            n=1
+            rate=alpha*Q/(v*n)
+        */
+
+        model1
+        {
+            type            patchInjection;
+            parcelBasisType fixed;
+            patchName       lowerInlet;
+            U0              (18.7939 6.8404 0);
+            nParticle       1;
+            parcelsPerSecond 1390885;
+            sizeDistribution
+            {
+                type        normal;
+                normalDistribution
+                {
+                    expectation 650e-6;
+                    variance 25e-6;
+                    minValue 500e-6;
+                    maxValue 800e-6;
+                }
+            }
+            flowRateProfile constant 1;
+            massTotal       0;
+            SOI 0;
+            duration 60;
+        }
+
+        model2
+        {
+            type            patchInjection;
+            parcelBasisType fixed;
+            patchName       upperInlet;
+            U0              (18.7939 6.8404 0);
+            nParticle       1;
+            parcelsPerSecond 1390885;
+            sizeDistribution
+            {
+                type        normal;
+                normalDistribution
+                {
+                    expectation 650e-6;
+                    variance 25e-6;
+                    minValue 500e-6;
+                    maxValue 800e-6;
+                }
+            }
+            flowRateProfile constant 1;
+            massTotal       0;
+            SOI 0;
+            duration 60;
+        }
+    }
+
+    dispersionModel none;
+
+    patchInteractionModel localInteraction;
+
+    localInteractionCoeffs
+    {
+        patches
+        (
+            frontAndBack
+            {
+                type rebound;
+                e    1;
+                mu   0;
+            }
+            walls
+            {
+                type rebound;
+                e    1;
+                mu   0;
+            }
+        );
+    }
+
+    heatTransferModel none;
+
+    surfaceFilmModel none;
+
+    packingModel none;
+
+    dampingModel relaxation;
+
+    relaxationCoeffs
+    {
+        timeScaleModel
+        {
+            type nonEquilibrium;
+            alphaPacked 0.58;
+            e 0.9;
+        }
+    }
+
+    isotropyModel stochastic;
+
+    stochasticCoeffs
+    {
+        timeScaleModel
+        {
+            type isotropic;
+            alphaPacked 0.58;
+            e 0.9;
+        }
+    }
+
+    stochasticCollisionModel none;
+
+    radiation off;
+}
+
+
+cloudFunctions
+{}
+
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/injectionChannel/constant/polyMesh/blockMeshDict b/tutorials/lagrangian/MPPICFoam/injectionChannel/constant/polyMesh/blockMeshDict
new file mode 100644
index 0000000000000000000000000000000000000000..6a6df642181cba8ba64d561ff249112eb83c361c
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/injectionChannel/constant/polyMesh/blockMeshDict
@@ -0,0 +1,181 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    object      blockMeshDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+convertToMeters 0.01;
+
+vertices
+(
+    ( 0                -3                 -0.5)
+    ( 2                -3                 -0.5)
+    ( 0                -3.727940468532405 -0.5)
+    ( 0.34202014332567 -4.667633089318313 -0.5)
+    ( 2.34202014332567 -3.939692620785910 -0.5)
+    ( 4.92380440016309 -3                 -0.5)
+    (41                -3                 -0.5)
+    (41                -6                 -0.5)
+    (53                -6                 -0.5)
+    (53                -3                 -0.5)
+    (53                 3                 -0.5)
+    (53                 6                 -0.5)
+    (41                 6                 -0.5)
+    (41                 3                 -0.5)
+    ( 4.92380440016309  3                 -0.5)
+    ( 2.34202014332567  3.939692620785910 -0.5)
+    ( 0.34202014332567  4.667633089318313 -0.5)
+    ( 0                 3.727940468532405 -0.5)
+    ( 2                 3                 -0.5)
+    ( 0                 3                 -0.5)
+    ( 3.46190220008154 -2.3               -0.5)
+    ( 3.46190220008154  2.3               -0.5)
+    ( 0                -3                  0.5)
+    ( 2                -3                  0.5)
+    ( 0                -3.727940468532405  0.5)
+    ( 0.34202014332567 -4.667633089318313  0.5)
+    ( 2.34202014332567 -3.939692620785910  0.5)
+    ( 4.92380440016309 -3                  0.5)
+    (41                -3                  0.5)
+    (41                -6                  0.5)
+    (53                -6                  0.5)
+    (53                -3                  0.5)
+    (53                 3                  0.5)
+    (53                 6                  0.5)
+    (41                 6                  0.5)
+    (41                 3                  0.5)
+    ( 4.92380440016309  3                  0.5)
+    ( 2.34202014332567  3.939692620785910  0.5)
+    ( 0.34202014332567  4.667633089318313  0.5)
+    ( 0                 3.727940468532405  0.5)
+    ( 2                 3                  0.5)
+    ( 0                 3                  0.5)
+    ( 3.46190220008154 -2.3                0.5)
+    ( 3.46190220008154  2.3                0.5)
+);
+
+blocks
+(
+    hex ( 0  1 18 19 22 23 40 41) ( 4 34  2) simpleGrading (1 1 1)
+    hex ( 1 20 21 18 23 42 43 40) ( 7 34  2) simpleGrading (1 1 1)
+    hex (20  5 14 21 42 27 36 43) ( 7 34  2) simpleGrading (1 1 1)
+    hex ( 5  6 13 14 27 28 35 36) (72 34  2) simpleGrading (1 1 1)
+    hex ( 6  9 10 13 28 31 32 35) (24 34  2) simpleGrading (1 1 1)
+
+    hex ( 7  8  9  6 29 30 31 28) (24 17  2) simpleGrading (1 1 1)
+    hex (13 10 11 12 35 32 33 34) (24 17  2) simpleGrading (1 1 1)
+
+    hex ( 3  4  1  2 25 26 23 24) ( 7  7  2) simpleGrading (1 1 1)
+    hex ( 4  5 20  1 26 27 42 23) ( 7  7  2) simpleGrading (1 1 1)
+    hex (18 21 14 15 40 43 36 37) ( 7  7  2) simpleGrading (1 1 1)
+    hex (17 18 15 16 39 40 37 38) ( 7  7  2) simpleGrading (1 1 1)
+);
+
+edges
+(
+);
+
+boundary
+(
+    walls
+    {
+        type wall;
+        faces
+        (
+            ( 0  1 23 22)
+            ( 1  2 24 23)
+
+            ( 3  4 26 25)
+            ( 4  5 27 26)
+            ( 5  6 28 27)
+            ( 6  7 29 28)
+            ( 7  8 30 29)
+
+            (11 12 34 33)
+            (12 13 35 34)
+            (13 14 36 35)
+            (14 15 37 36)
+            (15 16 38 37)
+
+            (17 18 40 39)
+            (18 19 41 40)
+            (19  0 22 41)
+        );
+    }
+
+    lowerInlet
+    {
+        type patch;
+        faces
+        (
+            (2 3 25 24)
+        );
+    }
+
+    upperInlet
+    {
+        type patch;
+        faces
+        (
+            (16 17 39 38)
+        );
+    }
+
+    outlet
+    {
+        type patch;
+        faces
+        (
+            (8 9 31 30)
+            (9 10 32 31)
+            (10 11 33 32)
+        );
+    }
+
+    frontAndBack
+    {
+        type symmetry;
+        faces
+        (
+            ( 0  1 18 19)
+            ( 1 20 21 18)
+            (20  5 14 21)
+            ( 5  6 13 14)
+            ( 6  9 10 13)
+    
+            ( 7  8  9  6)
+            (13 10 11 12)
+    
+            ( 3  4  1  2)
+            ( 4  5 20  1)
+            (18 21 14 15)
+            (17 18 15 16)
+    
+            (22 23 40 41)
+            (23 42 43 40)
+            (42 27 36 43)
+            (27 28 35 36)
+            (28 31 32 35)
+    
+            (29 30 31 28)
+            (35 32 33 34)
+    
+            (25 26 23 24)
+            (26 27 42 23)
+            (40 43 36 37)
+            (39 40 37 38)
+        );
+    }
+);
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/injectionChannel/constant/transportProperties b/tutorials/lagrangian/MPPICFoam/injectionChannel/constant/transportProperties
new file mode 100644
index 0000000000000000000000000000000000000000..4d91af2fb3827a82afbf628abd3db0b9332d2183
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/injectionChannel/constant/transportProperties
@@ -0,0 +1,25 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      transportProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+contiuousPhaseName air;
+
+rho.air         1.2;
+
+transportModel  Newtonian;
+nu              1e-05;
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/injectionChannel/constant/turbulenceProperties.air b/tutorials/lagrangian/MPPICFoam/injectionChannel/constant/turbulenceProperties.air
new file mode 100644
index 0000000000000000000000000000000000000000..1296429b72a21953def920b08774aa75e1d048b1
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/injectionChannel/constant/turbulenceProperties.air
@@ -0,0 +1,20 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      turbulenceProperties.air;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+simulationType  laminar;
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/injectionChannel/system/controlDict b/tutorials/lagrangian/MPPICFoam/injectionChannel/system/controlDict
new file mode 100644
index 0000000000000000000000000000000000000000..8329f435e1cbe90e71f417237fc05857acca3ed1
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/injectionChannel/system/controlDict
@@ -0,0 +1,48 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "system";
+    object      controlDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+application     MPPICFoam;
+
+startFrom       startTime;
+
+startTime       0.0;
+
+stopAt          endTime;
+
+endTime         0.1;
+
+deltaT          1e-4;
+
+writeControl    runTime;
+
+writeInterval   0.001;
+
+purgeWrite      0;
+
+writeFormat     ascii;
+
+writePrecision  6;
+
+writeCompression uncompressed;
+
+timeFormat      general;
+
+timePrecision   6;
+
+runTimeModifiable yes;
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/injectionChannel/system/fvSchemes b/tutorials/lagrangian/MPPICFoam/injectionChannel/system/fvSchemes
new file mode 100644
index 0000000000000000000000000000000000000000..42d5515ba862101db91e7f1695329b5c20c2eff5
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/injectionChannel/system/fvSchemes
@@ -0,0 +1,56 @@
+/*--------------------------------*- 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      fvSchemes;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+ddtSchemes
+{
+    default Euler;
+}
+
+gradSchemes
+{
+    default         Gauss linear;
+}
+
+divSchemes
+{
+    default         none;
+
+    div(alphaPhic,U.air)    Gauss linearUpwindV unlimited;
+    div(((alpha.air*nuEff)*dev2(T(grad(U.air))))) Gauss linear;
+}
+
+laplacianSchemes
+{
+    default         Gauss linear corrected;
+}
+
+interpolationSchemes
+{
+    default         linear;
+}
+
+snGradSchemes
+{
+    default         corrected;
+}
+
+fluxRequired
+{
+    default         no;
+    p;
+}
+
+// ************************************************************************* //
diff --git a/tutorials/lagrangian/MPPICFoam/injectionChannel/system/fvSolution b/tutorials/lagrangian/MPPICFoam/injectionChannel/system/fvSolution
new file mode 100644
index 0000000000000000000000000000000000000000..b79164acae34c932175b1a5b0be21edbe6eea2c6
--- /dev/null
+++ b/tutorials/lagrangian/MPPICFoam/injectionChannel/system/fvSolution
@@ -0,0 +1,75 @@
+/*--------------------------------*- 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          GAMG;
+        tolerance       1e-06;
+        relTol          0.01;
+        smoother        GaussSeidel;
+        cacheAgglomeration true;
+        nCellsInCoarsestLevel 10;
+        agglomerator    faceAreaPair;
+        mergeLevels     1;
+    }
+
+    pFinal
+    {
+        solver          GAMG;
+        tolerance       1e-06;
+        relTol          0;
+        smoother        GaussSeidel;
+        cacheAgglomeration true;
+        nCellsInCoarsestLevel 10;
+        agglomerator    faceAreaPair;
+        mergeLevels     1;
+    }
+
+    "(U|k|omega).*"
+    {
+        solver          PBiCG;
+        preconditioner  DILU;
+        tolerance       1e-05;
+        relTol          0.1;
+    }
+
+    "(U|k|omega).*Final"
+    {
+        $U;
+        tolerance       1e-05;
+        relTol          0;
+    }
+}
+
+PIMPLE
+{
+    nOuterCorrectors 1;
+    nCorrectors     2;
+    momentumPredictor yes;
+    nNonOrthogonalCorrectors 0;
+    pRefCell        0;
+    pRefValue       0;
+}
+
+relaxationFactors
+{
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/mesh/moveDynamicMesh/simpleHarmonicMotion/0.org/pointDisplacement b/tutorials/mesh/moveDynamicMesh/simpleHarmonicMotion/0.org/pointDisplacement
index d2b845620a516e4b0fe75dac9535d4fae1b436e5..d987171bd14c4204150784600029379bfad7ed7d 100644
--- a/tutorials/mesh/moveDynamicMesh/simpleHarmonicMotion/0.org/pointDisplacement
+++ b/tutorials/mesh/moveDynamicMesh/simpleHarmonicMotion/0.org/pointDisplacement
@@ -33,7 +33,6 @@ boundaryField
         momentOfInertia (0.1052 0.1052 0.1778);
         mass            9.6;
         velocity        (0 0 0);
-        orientation     (1 0 0 0 1 0 0 0 1);
         acceleration    (0 0 0);
         angularMomentum (0 0 0);
         torque          (0 0 0);
@@ -46,38 +45,24 @@ boundaryField
             {
                 sixDoFRigidBodyMotionRestraint linearSpring;
 
-                linearSpringCoeffs
-                {
-                    anchor          (0.5 0.5 1);
-                    refAttachmentPt $centreOfMass;
-                    stiffness       5000;
-                    damping         50;
-                    restLength      0.4;
-                }
+                anchor          (0.5 0.5 1);
+                refAttachmentPt $centreOfMass;
+                stiffness       5000;
+                damping         50;
+                restLength      0.4;
             }
         }
         constraints
         {
-            maxIterations       500;
-
-            fixedAxes1
+            fixedOrientation
             {
-                sixDoFRigidBodyMotionConstraint fixedOrientation;
-                tolerance           1e-6;
-                relaxationFactor    1.0;
-                fixedOrientationCoeffs {}
+                sixDoFRigidBodyMotionConstraint orientation;
             }
 
-            fixedLine1
+            zLine
             {
-                sixDoFRigidBodyMotionConstraint fixedLine;
-                tolerance           1e-6;
-                relaxationFactor    1.0;
-                fixedLineCoeffs
-                {
-                    refPoint      $centreOfMass;
-                    direction     (0 0 1);
-                }
+                sixDoFRigidBodyMotionConstraint line;
+                direction           (0 0 1);
             }
         }
         value           uniform (0 0 0);
diff --git a/tutorials/mesh/moveDynamicMesh/simpleHarmonicMotion/constant/dynamicMeshDict b/tutorials/mesh/moveDynamicMesh/simpleHarmonicMotion/constant/dynamicMeshDict
index b4afb71442198246bea160a90756a68d8d1d807c..ad68458956fba70dd6b906b5655332099e1cb282 100644
--- a/tutorials/mesh/moveDynamicMesh/simpleHarmonicMotion/constant/dynamicMeshDict
+++ b/tutorials/mesh/moveDynamicMesh/simpleHarmonicMotion/constant/dynamicMeshDict
@@ -16,7 +16,7 @@ FoamFile
 
 dynamicFvMesh      dynamicMotionSolverFvMesh;
 
-motionSolverLibs ("libfvMotionSolvers.so");
+motionSolverLibs ("libfvMotionSolvers.so" "libsixDoFRigidBodyMotion.so");
 
 solver            displacementLaplacian;
 
diff --git a/tutorials/multiphase/interDyMFoam/ras/floatingObject/constant/polyMesh/boundary b/tutorials/multiphase/interDyMFoam/ras/floatingObject/constant/polyMesh/boundary
index 1543006b7ac2cf94c682d7432780a0bd0d678615..adb36836efd1eb37c68ccb1e54ef42fc227f638f 100644
--- a/tutorials/multiphase/interDyMFoam/ras/floatingObject/constant/polyMesh/boundary
+++ b/tutorials/multiphase/interDyMFoam/ras/floatingObject/constant/polyMesh/boundary
@@ -20,6 +20,7 @@ FoamFile
     stationaryWalls
     {
         type            wall;
+        inGroups        1(wall);
         nFaces          11200;
         startFace       277808;
     }
@@ -32,6 +33,7 @@ FoamFile
     floatingObject
     {
         type            wall;
+        inGroups        1(wall);
         nFaces          672;
         startFace       290608;
     }
diff --git a/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/U b/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/U
index 373561912991882c87ef3a5828301580db60c5df..8b03633eb9cadb3767903fec8ccf4a26fd0db7b0 100644
--- a/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/U
+++ b/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/U
@@ -31,7 +31,7 @@ boundaryField
         value           uniform (460 0 0);
     }
 
-    wall
+    walls
     {
         type            fixedValue;
         value           uniform (0 0 0);
diff --git a/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/alpha.fuel b/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/alpha.fuel
index baf41e0bb39de6cc40881d524c069d522a56c79b..b6b34155c19d92573f678d1ce70f0baf92d40f8e 100644
--- a/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/alpha.fuel
+++ b/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/alpha.fuel
@@ -31,7 +31,7 @@ boundaryField
         value           uniform 1;
     }
 
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/k b/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/k
index b42409456a9db3386c16aadf9e7f16a87d7b5cd1..948e99914a9568db94ae2d0296c669fb44b70cdd 100644
--- a/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/k
+++ b/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/k
@@ -31,7 +31,7 @@ boundaryField
         value           uniform 1e-05;
     }
 
-    wall
+    walls
     {
         type            fixedValue;
         value           uniform 1e-11;
diff --git a/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/nuSgs b/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/nuSgs
index 202a0d920760d596a55719c5574bfced30a36327..95e02c374ead3fedc9215a0921654b85fd66cc51 100644
--- a/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/nuSgs
+++ b/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/nuSgs
@@ -30,7 +30,7 @@ boundaryField
         type            zeroGradient;
     }
 
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/nuTilda b/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/nuTilda
index 56a11e4e7103691722c4a224b7e140ab2cd0394b..bbbcc3b281aca331473e4746afc36e4dbe0db9e5 100644
--- a/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/nuTilda
+++ b/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/nuTilda
@@ -31,7 +31,7 @@ boundaryField
         value           uniform 0;
     }
 
-    wall
+    walls
     {
         type            fixedValue;
         value           uniform 0;
diff --git a/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/p_rgh b/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/p_rgh
index 120a41b910947ba3978accad7e1983f9493b2589..7590b3df5d5f51e719d2a2a592abddaf15ec0d2d 100644
--- a/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/p_rgh
+++ b/tutorials/multiphase/interFoam/les/nozzleFlow2D/0/p_rgh
@@ -30,7 +30,7 @@ boundaryField
         type            zeroGradient;
     }
 
-    wall
+    walls
     {
         type            zeroGradient;
     }
diff --git a/tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/polyMesh/blockMeshDict b/tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/polyMesh/blockMeshDict
index 07136745bfa1a8867d8b46cebff322c9aad29c81..a0f3c09a37c16dfd1162c501316231476c608ab4 100644
--- a/tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/polyMesh/blockMeshDict
+++ b/tutorials/multiphase/interFoam/les/nozzleFlow2D/constant/polyMesh/blockMeshDict
@@ -82,7 +82,7 @@ boundary
         );
     }
 
-    wall
+    walls
     {
         type wall;
         faces