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..8a4d6cc23b9220e4937da68a44c3d8ef09bb59a7
--- /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/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/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..2b142fae6323e149d6f158550b8cc54f25a3402c
--- /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 collisions 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/MPPICParcel/MPPICParcel.C b/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcel.C
new file mode 100644
index 0000000000000000000000000000000000000000..3844d22f673ebc0185168e10bf873164df188cf5
--- /dev/null
+++ b/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcel.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 "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);
+
+            break;
+        }
+        case TrackData::tpPackingNoTrack:
+        {
+            p.UCorrect() =
+                td.cloud().packingModel().velocityCorrection(p, trackTime);
+
+            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..d0917a06effd2a458b78d50a2db813e4d5d88a01
--- /dev/null
+++ b/src/lagrangian/intermediate/parcels/Templates/MPPICParcel/MPPICParcel.H
@@ -0,0 +1,314 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  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 collision modelling
+
+SourceFiles
+    MPPICParcelI.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..ee9b03870e1c1f237c67fea8b3e34a79a36cddd1
--- /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
+    basicKinematicParcel.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..5154df3a245061aa3cf1ae7239c901174383f3f4
--- /dev/null
+++ b/src/lagrangian/intermediate/parcels/derived/basicKinematicMPPICParcel/makeBasicKinematicMPPICParcelSubmodels.C
@@ -0,0 +1,65 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  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/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/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..909459ceb4faded43a24d17f70b766edaf9e40ff
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/AveragingMethod/AveragingMethod.H
@@ -0,0 +1,206 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  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 averaging lagrangian fields
+
+SourceFiles
+    AveragingMethod.C
+
+\*---------------------------------------------------------------------------*/
+
+#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..d0b32e36d2b89256a036342c87d0ae8ac96dd79f
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Basic/Basic.H
@@ -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/>.
+
+Class
+    Foam::AveragingMethods::Basic
+
+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..d86436fa956bf9207f0addf5da28fdcd517f0c5b
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Dual/Dual.H
@@ -0,0 +1,189 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  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
+
+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..1f8df2cf4db1076efeaa4fe69747cb82ee860d7a
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/AveragingMethods/Moment/Moment.H
@@ -0,0 +1,172 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  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
+
+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..b5ecba77fb04da671b8091d42fc04dba4ca02428
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/CorrectionLimitingMethod/CorrectionLimitingMethod.H
@@ -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/>.
+
+Class
+    Foam::CorrectionLimitingMethod
+
+Description
+
+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..ef242a4c1301c224c0ab5a8c3d58e77f761f7e01
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/absolute/absolute.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::CorrectionLimitingMethods::absolute
+
+Description
+
+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..275ab396a08804324e7551112786b08db5df7f4e
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/CorrectionLimitingMethods/relative/relative.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::CorrectionLimitingMethods::relative
+
+Description
+
+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..356cb7278675e064ed507a86f273fe5edde1be78
--- /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
+    Templated Damping model class.
+
+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..ee8274b783be95f808d0bf7b87cbea2dc0b12509
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/NoDamping/NoDamping.H
@@ -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/>.
+
+Class
+    Foam::NoDamping
+
+Description
+    Templated NoDamping model class.
+
+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..f1859cd7de5bec597780cb439b1de15e3ed8d150
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/DampingModels/Relaxation/Relaxation.H
@@ -0,0 +1,123 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  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::Relaxation
+
+Description
+    Templated Relaxation model class.
+
+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..ad3b500363aef02115105e850caf3227b02e8d08
--- /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
+    Templated Isotropy model class.
+
+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..071b01d53c781692cc24a77439b7902861dcdd65
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/NoIsotropy/NoIsotropy.H
@@ -0,0 +1,108 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  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::NoIsotropy
+
+Description
+    Templated NoIsotropy model class.
+
+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..fb3893fa20948010ee182a4edf8f147285924a79
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/IsotropyModels/Stochastic/Stochastic.H
@@ -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/>.
+
+Class
+    Foam::Stochastic
+
+Description
+    Templated Stochastic model class.
+
+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..b3dd1a557175fcdc9e46758a84d01d6269af4aa4
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/Explicit/Explicit.H
@@ -0,0 +1,126 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  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::Explicit
+
+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..095fed016bb0a2f94a9d244d609deb753ce5a2d4
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/Implicit/Implicit.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::Implicit
+
+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..a7aa5ce84e68af69e0e4ec1383e473ff7a576597
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/PackingModels/NoPacking/NoPacking.H
@@ -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/>.
+
+Class
+    Foam::NoPacking
+
+Description
+    Templated NoPacking model class.
+
+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..d29af9c44986d3b0cbaa41ed3b6258cac376c469
--- /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
+    Templated Packing model class.
+
+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..e9b6f0210c09d8435b5bc48ca45e96741046ccdb
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/HarrisCrighton/HarrisCrighton.H
@@ -0,0 +1,121 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  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 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..ace89618fb82e3e8c7018595828575974960d132
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/Lun/Lun.H
@@ -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/>.
+
+\*---------------------------------------------------------------------------*/
+
+#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..bea5dade3163d0ffa3b36bc1c48479c244eed41e
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/ParticleStressModel/ParticleStressModel.H
@@ -0,0 +1,138 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  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 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..8eb29a0cb666f940ffcafdf460a34d0e81a11a3d
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/ParticleStressModels/exponential/exponential.H
@@ -0,0 +1,115 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  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 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..b103d528cf6dd2451b21dd42cffca3fc42c1e4f8
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/TimeScaleModel/TimeScaleModel.H
@@ -0,0 +1,123 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  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 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..0fa635f935ac0d2051cdbab4d6b32dc688974418
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/equilibrium/equilibrium.H
@@ -0,0 +1,96 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  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 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..6eb3cef0fc128ae4a762d5b31c6b0f65a101cf99
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/isotropic/isotropic.H
@@ -0,0 +1,96 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  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 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..4cb1143e844f52347453be765a5b50e47e8b5c00
--- /dev/null
+++ b/src/lagrangian/intermediate/submodels/MPPIC/TimeScaleModels/nonEquilibrium/nonEquilibrium.H
@@ -0,0 +1,96 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  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 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/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
+(
+);
+
+// ************************************************************************* //