diff --git a/src/TurbulenceModels/compressible/Make/files b/src/TurbulenceModels/compressible/Make/files
index c7b6100132fc7e76581b4abf95517337c7750dae..44cc2ab1111101aa7b3d93882e07c37b47d4b9cf 100644
--- a/src/TurbulenceModels/compressible/Make/files
+++ b/src/TurbulenceModels/compressible/Make/files
@@ -13,6 +13,7 @@ $(BCs)/convectiveHeatTransfer/convectiveHeatTransferFvPatchScalarField.C
 $(BCs)/fixedIncidentRadiation/fixedIncidentRadiationFvPatchScalarField.C
 $(BCs)/lumpedMassWallTemperature/lumpedMassWallTemperatureFvPatchScalarField.C
 $(BCs)/outletMappedUniformInletHeatAddition/outletMappedUniformInletHeatAdditionFvPatchField.C
+$(BCs)/outletMachNumberPressure/outletMachNumberPressureFvPatchScalarField.C
 
 turbulentFluidThermoModels/derivedFvPatchFields/wallFunctions/alphatWallFunctions/alphatWallFunction/alphatWallFunctionFvPatchScalarField.C
 turbulentFluidThermoModels/derivedFvPatchFields/wallFunctions/alphatWallFunctions/alphatJayatillekeWallFunction/alphatJayatillekeWallFunctionFvPatchScalarField.C
diff --git a/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/outletMachNumberPressure/outletMachNumberPressureFvPatchScalarField.C b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/outletMachNumberPressure/outletMachNumberPressureFvPatchScalarField.C
new file mode 100644
index 0000000000000000000000000000000000000000..e91be31448d65acc6532ffe6256d72bbb8e7c86f
--- /dev/null
+++ b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/outletMachNumberPressure/outletMachNumberPressureFvPatchScalarField.C
@@ -0,0 +1,278 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2018 OpenCFD Ltd.
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+\*---------------------------------------------------------------------------*/
+
+#include "outletMachNumberPressureFvPatchScalarField.H"
+#include "addToRunTimeSelectionTable.H"
+#include "fvPatchFieldMapper.H"
+#include "volFields.H"
+#include "surfaceFields.H"
+#include "fluidThermo.H"
+#include "constants.H"
+
+// * * * * * * * * * * * * * * * * Constructors  * * * * * * * * * * * * * * //
+
+Foam::outletMachNumberPressureFvPatchScalarField::
+outletMachNumberPressureFvPatchScalarField
+(
+    const fvPatch& p,
+    const DimensionedField<scalar, volMesh>& iF
+)
+:
+    fixedValueFvPatchScalarField(p, iF),
+    M_(1),
+    pBack_(0.0),
+    c1_(0.0),
+    A1_(0.0),
+    phiName_("phi"),
+    rhoName_("rho"),
+    UName_("U"),
+    choked_(false),
+    relax_(0.0)
+{}
+
+
+Foam::outletMachNumberPressureFvPatchScalarField::
+outletMachNumberPressureFvPatchScalarField
+(
+    const fvPatch& p,
+    const DimensionedField<scalar, volMesh>& iF,
+    const dictionary& dict
+)
+:
+    fixedValueFvPatchScalarField(p, iF, dict),
+    M_(dict.lookupOrDefault<scalar>("M", 0.0)),
+    pBack_(readScalar(dict.lookup("pBack"))),
+    c1_(dict.lookupOrDefault<scalar>("c1", 0.0)),
+    A1_(dict.lookupOrDefault<scalar>("A1", 0.0)),
+    phiName_(dict.lookupOrDefault<word>("phi", "phi")),
+    rhoName_(dict.lookupOrDefault<word>("rho", "rho")),
+    UName_(dict.lookupOrDefault<word>("U", "U")),
+    choked_(dict.lookup("choked")),
+    relax_(dict.lookupOrDefault<scalar>("relax", 0))
+{
+    Info<< "The outletMachNumber pressure BC is using the flag choked: "
+        <<  choked_  << endl;
+}
+
+
+Foam::outletMachNumberPressureFvPatchScalarField::
+outletMachNumberPressureFvPatchScalarField
+(
+    const outletMachNumberPressureFvPatchScalarField& ptf,
+    const fvPatch& p,
+    const DimensionedField<scalar, volMesh>& iF,
+    const fvPatchFieldMapper& mapper
+)
+:
+    fixedValueFvPatchScalarField(ptf, p, iF, mapper),
+    M_(ptf.M_),
+    pBack_(ptf.pBack_),
+    c1_(ptf.c1_),
+    A1_(ptf.A1_),
+    phiName_(ptf.phiName_),
+    rhoName_(ptf.rhoName_),
+    UName_(ptf.UName_),
+    choked_(ptf.choked_),
+    relax_(ptf.relax_)
+{}
+
+
+Foam::outletMachNumberPressureFvPatchScalarField::
+outletMachNumberPressureFvPatchScalarField
+(
+    const outletMachNumberPressureFvPatchScalarField& tppsf
+)
+:
+    fixedValueFvPatchScalarField(tppsf),
+    M_(tppsf.M_),
+    pBack_(tppsf.pBack_),
+    c1_(tppsf.c1_),
+    A1_(tppsf.A1_),
+    phiName_(tppsf.phiName_),
+    rhoName_(tppsf.rhoName_),
+    UName_(tppsf.UName_),
+    choked_(tppsf.choked_),
+    relax_(tppsf.relax_)
+{}
+
+
+Foam::outletMachNumberPressureFvPatchScalarField::
+outletMachNumberPressureFvPatchScalarField
+(
+    const outletMachNumberPressureFvPatchScalarField& tppsf,
+    const DimensionedField<scalar, volMesh>& iF
+)
+:
+    fixedValueFvPatchScalarField(tppsf, iF),
+    M_(tppsf.M_),
+    pBack_(tppsf.pBack_),
+    c1_(tppsf.c1_),
+    A1_(tppsf.A1_),
+    phiName_(tppsf.phiName_),
+    rhoName_(tppsf.rhoName_),
+    UName_(tppsf.UName_),
+    choked_(tppsf.choked_),
+    relax_(tppsf.relax_)
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions  * * * * * * * * * * * * * //
+
+void Foam::outletMachNumberPressureFvPatchScalarField::updateCoeffs()
+{
+    if (updated())
+    {
+        return;
+    }
+
+     const volScalarField& p =
+        db().lookupObject<volScalarField>
+        (
+            this->internalField().name()
+        );
+
+    const label patchi = patch().index();
+
+    const scalarField pb(p.oldTime().boundaryField()[patchi]);
+
+    const fvsPatchField<scalar>& phi =
+        patch().lookupPatchField<surfaceScalarField, scalar>(phiName_);
+
+    // Calculate the current mass flow rate
+    if (phi.internalField().dimensions() != dimDensity*dimVelocity*dimArea)
+    {
+        FatalErrorInFunction
+            <<"phi is not a mass flux." << exit(FatalError);
+    }
+
+    const fluidThermo* thermoPtr =
+        db().lookupObjectPtr<fluidThermo>(basicThermo::dictName);
+
+    const volVectorField& U = db().lookupObject<volVectorField>(UName_);
+
+    vectorField Ub(U.boundaryField()[patchi]);
+    const vectorField UbOld(U.oldTime().boundaryField()[patchi]);
+
+    // relax U
+    Ub = relax_*UbOld + (1 -relax_)*Ub;
+
+    const scalarField gamma(thermoPtr->gamma()().boundaryField()[patchi]);
+
+    const fvPatchField<scalar>& rho =
+        patch().lookupPatchField<volScalarField, scalar>(rhoName_);
+
+    const scalarField Mb(mag(Ub)/sqrt(gamma*pb/rho));
+
+    const scalarField ptot
+    (
+        pb*(pow(1 + (gamma-1)/2*sqr(gAverage(Mb)), gamma/(gamma-1)))
+    );
+
+    scalarField M(patch().size(), 1.0);
+
+    if (choked_)
+    {
+        if (M_ > 0.0)
+        {
+            M = M_;
+        }
+        else
+        {
+            FatalErrorInFunction <<" Mach number is lower than zero" << endl
+                << "Pelase specify M in the dictionary"
+                << exit(FatalError);
+        }
+    }
+    else
+    {
+
+        if (A1_ == 0.0 || c1_ == 0.0)
+        {
+             FatalErrorInFunction <<" Please enter values for A1 and c1" << endl
+                << exit(FatalError);
+        }
+
+        const scalarField r = pBack_/ptot;
+        const scalar area = gSum(mag(patch().Sf()));
+        M =
+            A1_/(c1_*area)
+           *sqrt(2/(gamma-1)*(pow(r, 2/gamma) - pow(r, (gamma+1)/gamma)));
+
+        forAll(M, i)
+        {
+            if (M[i] < 0 || r[i] >=1)
+            {
+                WarningInFunction <<" Mach number is lower than zero" << endl
+                    << "or pBack/ptot ratio is larger then one"
+                    << endl;
+            }
+        }
+    }
+
+    scalarField pbNew
+    (
+        ptot/(pow(1 + (gamma-1)/2*sqr(gAverage(M)), gamma/(gamma-1)))
+    );
+
+    // relax pressure
+    pbNew = relax_*pb + (1 -relax_)*pbNew;
+
+    operator==(pbNew);
+
+    fixedValueFvPatchScalarField::updateCoeffs();
+}
+
+
+void Foam::outletMachNumberPressureFvPatchScalarField::write(Ostream& os) const
+{
+    fvPatchScalarField::write(os);
+    os.writeEntry("pBack", pBack_);
+    os.writeEntryIfDifferent("c1", 0.0, c1_);
+    os.writeEntryIfDifferent("A1", 0.0, A1_);
+    os.writeEntry("choked", choked_);
+    os.writeEntryIfDifferent("relax", 0.0, relax_);
+
+    os.writeEntryIfDifferent<word>("phi", "phi", phiName_);
+    os.writeEntryIfDifferent<word>("rho", "rho", rhoName_);
+    os.writeEntryIfDifferent<word>("U", "U", UName_);
+    os.writeEntryIfDifferent<scalar>("M", 0.0, M_);
+
+    writeEntry("value", os);
+}
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+    makePatchTypeField
+    (
+        fvPatchScalarField,
+        outletMachNumberPressureFvPatchScalarField
+    );
+}
+
+// ************************************************************************* //
+
diff --git a/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/outletMachNumberPressure/outletMachNumberPressureFvPatchScalarField.H b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/outletMachNumberPressure/outletMachNumberPressureFvPatchScalarField.H
new file mode 100644
index 0000000000000000000000000000000000000000..e3af95d7980f6a51d152cd5a590e9d1783b93c4a
--- /dev/null
+++ b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/outletMachNumberPressure/outletMachNumberPressureFvPatchScalarField.H
@@ -0,0 +1,229 @@
+/*---------------------------------------------------------------------------*\
+  =========                 |
+  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
+   \\    /   O peration     |
+    \\  /    A nd           | Copyright (C) 2018 OpenCFD Ltd.
+     \\/     M anipulation  |
+-------------------------------------------------------------------------------
+License
+    This file is part of OpenFOAM.
+
+    OpenFOAM is free software: you can redistribute it and/or modify it
+    under the terms of the GNU General Public License as published by
+    the Free Software Foundation, either version 3 of the License, or
+    (at your option) any later version.
+
+    OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
+    ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
+    FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public License
+    for more details.
+
+    You should have received a copy of the GNU General Public License
+    along with OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
+
+Class
+    Foam::outletMachNumberPressureFvPatchScalarField
+
+Group
+    grpOutletBoundaryConditions
+
+Description
+    This BC set the outlet pressure for compressible flows is such as a
+    choked condition is achieved given an input Mach number.
+    Optionally, if the BC is operated in a non-choked condition (choked false),
+    the constants C1 and A1 are used to calculate the corresponding Mach number at
+    the outlet.
+
+    The static pressure is calculates as :
+
+        p_s = p_tot / [1+(k-1)/2*M^2]^(k/(k-1))
+
+    where
+
+    p_tot: [Pa] mass averaged total pressure on outlet patch
+    k: [-] mass averaged heat capacity ratio on outlet patch
+    M: [-] target Mach number on the outlet patch defining as either choked or non-choked
+
+    For choked conditions:
+
+        M = constant defined in dict
+
+    For non-choked conditions:
+
+        M = A1/(C1*A_outlet)*sqrt(2/(k-1)*[r^(2/k)-r^((k+1)/k)], r=p_back/p_tot
+
+    where
+
+        A_outlet: [m2] area of outlet patch
+        A1: [m2] constant defined in dict
+        C1: [-] constant defined in dict
+        p_back: [Pa] constant defined in dict
+
+
+Usage
+    \table
+        Property        | Description                 | Required | Default value
+        pBack           | Back pressure               | yes
+        M               | Average desired mach number | no
+        C1              | Model input                 | no       | 0.0
+        A1              | Model input                 | no       | 0.0
+        choked          | The outlet is considered chocked | yes
+        relax           | relaxation factor (1 fully relax) | no | 0.0
+    \endtable
+
+    Example of the boundary condition specification:
+    \verbatim
+    <patchName>
+    {
+        type            outletMachNumberPressure;
+        pBack           101325;
+        c1              1;
+        A1              0.008;
+        choked          false;
+        value           uniform 101325;
+    }
+    \endverbatim
+
+SourceFiles
+    outletMachNumberPressureFvPatchScalarField.C
+
+\*---------------------------------------------------------------------------*/
+
+#ifndef outletMachNumberPressureFvPatchScalarField_H
+#define outletMachNumberPressureFvPatchScalarField_H
+
+#include "fixedValueFvPatchFields.H"
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+namespace Foam
+{
+
+/*---------------------------------------------------------------------------*\
+                      Class plenumPressureFvPatch Declaration
+\*---------------------------------------------------------------------------*/
+
+class outletMachNumberPressureFvPatchScalarField
+:
+    public fixedValueFvPatchScalarField
+{
+    // Private data
+
+        //- Mach number
+        scalar M_;
+
+        //- Back pressure
+        scalar pBack_;
+
+        //- Model constant
+        scalar c1_;
+
+        //- Model constant area input
+        scalar A1_;
+
+        //- The name of the flux field
+        word phiName_;
+
+        //- The name of the rho field
+        word rhoName_;
+
+        //- The name of the U field
+        word UName_;
+
+        //- Choked
+        Switch choked_;
+
+        //- Relaxation factor
+        scalar relax_;
+
+
+public:
+
+    //- Runtime type information
+    TypeName("outletMachNumberPressure");
+
+
+    // Constructors
+
+        //- Construct from patch and internal field
+        outletMachNumberPressureFvPatchScalarField
+        (
+            const fvPatch&,
+            const DimensionedField<scalar, volMesh>&
+        );
+
+        //- Construct from patch, internal field and dictionary
+        outletMachNumberPressureFvPatchScalarField
+        (
+            const fvPatch&,
+            const DimensionedField<scalar, volMesh>&,
+            const dictionary&
+        );
+
+        //- Construct by mapping given outletMachNumberPressureFvPatchScalarField
+        //  onto a new patch
+        outletMachNumberPressureFvPatchScalarField
+        (
+            const outletMachNumberPressureFvPatchScalarField&,
+            const fvPatch&,
+            const DimensionedField<scalar, volMesh>&,
+            const fvPatchFieldMapper&
+        );
+
+        //- Construct as copy
+        outletMachNumberPressureFvPatchScalarField
+        (
+            const outletMachNumberPressureFvPatchScalarField&
+        );
+
+        //- Construct and return a clone
+        virtual tmp<fvPatchScalarField> clone() const
+        {
+            return tmp<fvPatchScalarField>
+            (
+                new outletMachNumberPressureFvPatchScalarField(*this)
+            );
+        }
+
+        //- Construct as copy setting internal field reference
+        outletMachNumberPressureFvPatchScalarField
+        (
+            const outletMachNumberPressureFvPatchScalarField&,
+            const DimensionedField<scalar, volMesh>&
+        );
+
+        //- Construct and return a clone setting internal field reference
+        virtual tmp<fvPatchScalarField> clone
+        (
+            const DimensionedField<scalar, volMesh>& iF
+        ) const
+        {
+            return tmp<fvPatchScalarField>
+            (
+                new outletMachNumberPressureFvPatchScalarField(*this, iF)
+            );
+        }
+
+
+    // Member functions
+
+        // Evaluation functions
+
+            //- Update the coefficients associated with the patch field
+            virtual void updateCoeffs();
+
+
+        //- Write
+        virtual void write(Ostream&) const;
+};
+
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+} // End namespace Foam
+
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+#endif
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/CH4 b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/CH4
new file mode 100644
index 0000000000000000000000000000000000000000..eb980c1130b3504cd2255b3848ffba6015cbf64e
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/CH4
@@ -0,0 +1,41 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           volScalarField;
+    location        "0";
+    object          CH4;
+}
+
+dimensions      [ 0 0 0 0 0 0 0 ];
+
+internalField   uniform 0;
+
+boundaryField
+{
+    inletair
+    {
+        type            fixedValue;
+        value           uniform 0;
+    }
+    outlet
+    {
+        type            inletOutlet;
+        inletValue      uniform 0;
+        value           uniform 0;
+    }
+    walls
+    {
+        type            zeroGradient;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/H2 b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/H2
new file mode 100644
index 0000000000000000000000000000000000000000..2d29db5ab15c6b5a2b39239d4ed7692e65a7b8b7
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/H2
@@ -0,0 +1,41 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           volScalarField;
+    location        "0";
+    object          H2;
+}
+
+dimensions      [ 0 0 0 0 0 0 0 ];
+
+internalField   uniform 0;
+
+boundaryField
+{
+    inletair
+    {
+        type            fixedValue;
+        value           uniform 0;
+    }
+    outlet
+    {
+        type            zeroGradient;
+        inletValue      uniform 0;
+        value           uniform 0;
+    }
+    walls
+    {
+        type            zeroGradient;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/H2O b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/H2O
new file mode 100644
index 0000000000000000000000000000000000000000..2d29db5ab15c6b5a2b39239d4ed7692e65a7b8b7
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/H2O
@@ -0,0 +1,41 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           volScalarField;
+    location        "0";
+    object          H2;
+}
+
+dimensions      [ 0 0 0 0 0 0 0 ];
+
+internalField   uniform 0;
+
+boundaryField
+{
+    inletair
+    {
+        type            fixedValue;
+        value           uniform 0;
+    }
+    outlet
+    {
+        type            zeroGradient;
+        inletValue      uniform 0;
+        value           uniform 0;
+    }
+    walls
+    {
+        type            zeroGradient;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/N2 b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/N2
new file mode 100644
index 0000000000000000000000000000000000000000..bc2b024fb95298c36a261b90d87b2472df3a193f
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/N2
@@ -0,0 +1,41 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           volScalarField;
+    location        "0";
+    object          N2;
+}
+
+dimensions      [ 0 0 0 0 0 0 0 ];
+
+internalField   uniform 0.7;
+
+boundaryField
+{
+    inletair
+    {
+        type            fixedValue;
+        value           uniform 0.7;
+    }
+    outlet
+    {
+        type            inletOutlet;
+        inletValue      uniform 0.7;
+        value           uniform 0.7;
+    }
+    walls
+    {
+        type            zeroGradient;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/O2 b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/O2
new file mode 100644
index 0000000000000000000000000000000000000000..ac2bd3d89aefd0401d08116efeee19d9baa7a2f5
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/O2
@@ -0,0 +1,41 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           volScalarField;
+    location        "0";
+    object          O2;
+}
+
+dimensions      [ 0 0 0 0 0 0 0 ];
+
+internalField   uniform 0.3;
+
+boundaryField
+{
+    inletair
+    {
+        type            fixedValue;
+        value           uniform 0.3;
+    }
+    outlet
+    {
+        type            inletOutlet;
+        inletValue      uniform 0.3;
+        value           uniform 0.3;
+    }
+    walls
+    {
+        type            zeroGradient;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/T b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/T
new file mode 100644
index 0000000000000000000000000000000000000000..4d697e45ed8ba89fab208535306d901794c3edbf
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/T
@@ -0,0 +1,50 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           volScalarField;
+    location        "0";
+    object          T;
+}
+
+dimensions      [ 0 0 0 1 0 0 0 ];
+
+internalField   uniform 292;
+
+boundaryField
+{
+    inletair
+    {
+        type            uniformFixedValue;
+        uniformValue
+        {
+            type            csvFile;
+            nHeaderLine     1;
+            refColumn       0;
+            componentColumns ( 2 );
+            separator       ",";
+            mergeSeparators no;
+            file            "$FOAM_CASE/constant/inlet.csv";
+        }
+    }
+    outlet
+    {
+        type            inletOutlet;
+        inletValue      uniform 292;
+        value           uniform 292;
+    }
+    walls
+    {
+        type            zeroGradient;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/U b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/U
new file mode 100644
index 0000000000000000000000000000000000000000..0d8dadfb9824d08be21d4d8935b2a7b72ceeb129
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/U
@@ -0,0 +1,51 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           volVectorField;
+    location        "0";
+    object          U;
+}
+
+dimensions      [ 0 1 -1 0 0 0 0 ];
+
+internalField   uniform ( 0 0 0 );
+
+boundaryField
+{
+    inletair
+    {
+        type            flowRateInletVelocity;
+        value           uniform ( 0 0 0 );
+        massFlowRate    csvFile;
+        nHeaderLine     1;
+        refColumn       0;
+        componentColumns ( 1 );
+        separator       ",";
+        mergeSeparators no;
+        file             "$FOAM_CASE/constant/inlet.csv";
+
+
+    }
+    outlet
+    {
+        type            pressureInletOutletVelocity;
+        value           uniform (0.0 0 0);
+        inletValue      uniform (0 0 0);
+    }
+    walls
+    {
+        type            fixedValue;
+        value           uniform ( 0 0 0 );
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/Ydefault b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/Ydefault
new file mode 100644
index 0000000000000000000000000000000000000000..3f640340133dc96e88dcd4c024e784bb6d9a814e
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/Ydefault
@@ -0,0 +1,41 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           volScalarField;
+    location        "0";
+    object          Ydefault;
+}
+
+dimensions      [ 0 0 0 0 0 0 0 ];
+
+internalField   uniform 0;
+
+boundaryField
+{
+    inletair
+    {
+        type            fixedValue;
+        value           uniform 0;
+    }
+    outlet
+    {
+        type            inletOutlet;
+        inletValue      uniform 0;
+        value           uniform 0;
+    }
+    walls
+    {
+        type            zeroGradient;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/alphat b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/alphat
new file mode 100644
index 0000000000000000000000000000000000000000..596a226489790d985ed5bce2c2b6f3846682ba3e
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/alphat
@@ -0,0 +1,42 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           volScalarField;
+    location        "0";
+    object          alphat;
+}
+
+dimensions      [ 1 -1 -1 0 0 0 0 ];
+
+internalField   uniform 0;
+
+boundaryField
+{
+    inletair
+    {
+        type            calculated;
+        value           uniform 0;
+    }
+    outlet
+    {
+        type            calculated;
+        value           uniform 0;
+    }
+    walls
+    {
+        type            compressible::alphatWallFunction;
+        Prt             0.85;
+        value           uniform 0;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/epsilon b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/epsilon
new file mode 100644
index 0000000000000000000000000000000000000000..a524441e08afbfa4be0de837acbcc1286c003b03
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/epsilon
@@ -0,0 +1,48 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           volScalarField;
+    location        "0";
+    object          epsilon;
+}
+
+dimensions      [ 0 2 -3 0 0 0 0 ];
+
+internalField   uniform 200;
+
+boundaryField
+{
+    inletair
+    {
+        type            turbulentMixingLengthDissipationRateInlet;
+        mixingLength    0.005;
+        phi             phi;
+        k               k;
+        value           uniform 200;
+    }
+    outlet
+    {
+        type            inletOutlet;
+        inletValue      uniform 200;
+        value           uniform 200;
+    }
+    walls
+    {
+        type            epsilonWallFunction;
+        Cmu             0.09;
+        kappa           0.41;
+        E               9.8;
+        value           uniform 200;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/k b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/k
new file mode 100644
index 0000000000000000000000000000000000000000..a6cae7dbe458cb6d9d24d31496e502f4b16d0adb
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/k
@@ -0,0 +1,43 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  v1706+                                |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           volScalarField;
+    location        "0";
+    object          k;
+}
+
+dimensions      [ 0 2 -2 0 0 0 0 ];
+
+internalField   uniform 1;
+
+boundaryField
+{
+    inletair
+    {
+        type            turbulentIntensityKineticEnergyInlet;
+        intensity       0.02;
+        value           uniform 1;
+    }
+    outlet
+    {
+        type            zeroGradient;//inletOutlet;
+        inletValue      uniform 1;
+        value           uniform 1;
+    }
+    walls
+    {
+        type            kqRWallFunction;
+        value           uniform 1;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/nut b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/nut
new file mode 100644
index 0000000000000000000000000000000000000000..2ea823af5232f633f3be49a8d0d05ed31525a02f
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/nut
@@ -0,0 +1,44 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  v1706+                                |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           volScalarField;
+    location        "0";
+    object          mut;
+}
+
+dimensions      [ 0 2 -1 0 0 0 0 ];
+
+internalField   uniform 0;
+
+boundaryField
+{
+    inletair
+    {
+        type            calculated;
+        value           uniform 0;
+    }
+    outlet
+    {
+        type            calculated;
+        value           uniform 0;
+    }
+    walls
+    {
+        type            nutkWallFunction;
+        Cmu             0.09;
+        kappa           0.41;
+        E               9.8;
+        value           uniform 0;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/p b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/p
new file mode 100644
index 0000000000000000000000000000000000000000..1d89fb0817400891ff060f9c132f338fa59aaaf4
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/0/p
@@ -0,0 +1,43 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           volScalarField;
+    location        "0";
+    object          p;
+}
+
+dimensions      [ 1 -1 -2 0 0 0 0 ];
+
+internalField   uniform 250000;
+
+boundaryField
+{
+    inletair
+    {
+        type            zeroGradient;
+    }
+    outlet
+    {
+        type            outletMachNumberPressure;
+        pBack           101325;
+        choked          true;
+        relax           0.1;
+        M               0.3;
+        value           uniform 250000;
+    }
+    walls
+    {
+        type            zeroGradient;
+    }
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/Allclean b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/Allclean
new file mode 100755
index 0000000000000000000000000000000000000000..f0bfad6c434f60fe19c91d34691e520b9ec18be4
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/Allclean
@@ -0,0 +1,8 @@
+#!/bin/sh
+cd ${0%/*} || exit 1    # Run from this directory
+
+# Source tutorial clean functions
+. $WM_PROJECT_DIR/bin/tools/CleanFunctions
+
+cleanCase
+#------------------------------------------------------------------------------
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/Allrun b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/Allrun
new file mode 100755
index 0000000000000000000000000000000000000000..81bd0203d0f7707e26f6f73c69b348375ac4508f
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/Allrun
@@ -0,0 +1,12 @@
+#!/bin/sh
+cd ${0%/*} || exit 1    # Run from this directory
+
+# Source tutorial run functions
+. $WM_PROJECT_DIR/bin/tools/RunFunctions
+
+runApplication blockMesh
+runApplication decomposePar
+runParallel $(getApplication)
+runApplication reconstructPar
+
+#------------------------------------------------------------------------------
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/chemistryProperties b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/chemistryProperties
new file mode 100644
index 0000000000000000000000000000000000000000..4f0df2a1ec0bcb33626e5196990a6d2febc759b1
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/chemistryProperties
@@ -0,0 +1,35 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           dictionary;
+    location        "constant";
+    object          chemistryProperties;
+}
+
+chemistryType
+{
+    chemistrySolver   ode;
+    chemistryThermo   psi;
+    TDAC              off;
+}
+
+initialChemicalTimeStep 1e-07;
+
+chemistry       off;
+
+odeCoeffs
+{
+    solver          Rosenbrock34;  // Rosenbrock34, seulex or rodas23
+    absTol          1e-12;
+    relTol          1e-7;
+}
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/combustionProperties b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/combustionProperties
new file mode 100644
index 0000000000000000000000000000000000000000..15aa2a8895a06c4915032632151ed462fbb22a4b
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/combustionProperties
@@ -0,0 +1,27 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      combustionProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+combustionModel  EDC<psiChemistryCombustion>;
+
+active  false;
+
+EDCCoeffs
+{
+    version v2005;
+}
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/g b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/g
new file mode 100644
index 0000000000000000000000000000000000000000..c925386e15a7892cf9de1e38477fcc77494c8715
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/g
@@ -0,0 +1,21 @@
+/*--------------------------------*- 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       uniformDimensionedVectorField;
+    location    "constant";
+    object      g;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+dimensions      [0 1 -2 0 0 0 0];
+value           (0 0 -9.81);
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/inlet.csv b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/inlet.csv
new file mode 100644
index 0000000000000000000000000000000000000000..7b9402d054c96f23eb5da283360c84352a26b165
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/inlet.csv
@@ -0,0 +1,969 @@
+Time(s), massflow(kg/s), temperature(K), massfractionh2o(), massfractionnh3(), massfractionair(), heatratio(), ptot(Pa)
+0,0,632.36997502323,0.033405082879638,0,0.966594917120362,0,226041.50885122
+0.001,0,631.901346644677,0.033370285467498,0,0.966629714532502,0,225999.900064424
+0.002,0,631.472403471796,0.033336763246274,0,0.966663236753726,0,225979.994105371
+0.003,0,631.087316385897,0.033304884163242,0,0.966695115836758,0,225979.392192801
+0.004,0,630.750350929119,0.033274957572388,0,0.966725042427612,0,225997.064438216
+0.005,0,630.465542576512,0.033247259665055,0,0.966752740334946,0,226032.497939271
+0.006,0,630.236500102407,0.033222040022136,0,0.966777959977864,0,226085.346578657
+0.007,0,630.0662738654,0.033199522419865,0,0.966800477580136,0,226155.268055305
+0.008,0,629.957264057339,0.033179903679275,0,0.966820096320725,0,226241.846826393
+0.009,0,629.911150125501,0.03316335186401,0,0.96683664813599,0,226344.553126257
+0.01,0,629.928835206545,0.033150004310948,0,0.966849995689052,0,226462.719686236
+0.011,0,630.010404603468,0.033139965744998,0,0.966860034255002,0,226595.528761865
+0.012,0,630.155096595076,0.033133306610649,0,0.966866693389351,0,226742.003877144
+0.013,0,630.361288982672,0.033130061743361,0,0.966869938256639,0,226901.007358802
+0.014,0,630.626501560759,0.03313022946147,0,0.96686977053853,0,227071.241970752
+0.015,0,630.947415729769,0.03313377114458,0,0.96686622885542,0,227251.256838656
+0.016,0,631.319913194157,0.033140611377877,0,0.966859388622123,0,227439.458617
+0.017,0,631.739130244925,0.033150638634113,0,0.966849361365887,0,227634.125319708
+0.018,0,632.199531110648,0.033163706579767,0,0.966836293420234,0,227833.42580538
+0.019,0,632.694995653632,0.033179635957359,0,0.966820364042641,0,228035.442417808
+0.02,0,633.218324552194,0.033198200995038,0,0.966801799004963,0,228237.921666854
+0.021,0,633.760469618073,0.033219081817669,0,0.966780918182331,0,228437.867924831
+0.022,0,634.311515117119,0.033241888589206,0,0.966758111410794,0,228632.069007259
+0.023,0,634.860854324652,0.03326617011871,0,0.96673382988129,0,228817.167862861
+0.024,0,635.397312048904,0.033291413846965,0,0.966708586153035,0,228989.681659809
+0.025,0,635.909295863523,0.033317046568296,0,0.966682953431704,0,229146.041989212
+0.026,0,636.384970554164,0.033342436079224,0,0.966657563920776,0,229282.652094185
+0.027,0,636.812923653251,0.033366952376519,0,0.966633047623481,0,229395.559096242
+0.028,0,637.184336549665,0.033390187484319,0,0.966609812515681,0,229479.354424768
+0.029,0,637.473812303327,0.033410683420965,0,0.966589316579035,0,229523.341349649
+0.03,0,637.645817047133,0.033426262434424,0,0.966573737565576,0,229513.241074671
+0.031,0,637.708442526631,0.033436698672234,0,0.966563301327766,0,229459.006568981
+0.032,0,637.670026736965,0.033441920338422,0,0.966558079661578,0,229368.450501546
+0.033,0,637.537407915595,0.033441867061516,0,0.966558132938484,0,229247.432701709
+0.034,0,637.315931234672,0.0334364531264,0,0.9665635468736,0,229100.558796652
+0.035,0,637.009909644082,0.033425599201447,0,0.966574400798553,0,228931.290979921
+0.036,0,636.624351494602,0.033409309514806,0,0.966590690485194,0,228743.112310263
+0.037,0,636.17284489194,0.033387961705402,0,0.966612038294598,0,228540.889183924
+0.038,0,635.650892701187,0.033361264156679,0,0.966638735843321,0,228323.029785437
+0.039,0,635.092204161421,0.033330931076248,0,0.966669068923752,0,228110.66503617
+0.04,0,634.541855261799,0.033299526104874,0,0.966700473895126,0,227925.399268234
+0.041,0,634.020675624958,0.033268560188286,0,0.966731439811714,0,227772.238067726
+0.042,0,633.534512207878,0.033238751241946,0,0.966761248758054,0,227647.96177375
+0.043,0,633.083630645304,0.033210438065138,0,0.966789561934862,0,227547.578619456
+0.044,0,632.666682134696,0.033183789665238,0,0.966816210334762,0,227466.524465026
+0.045,0,632.281966333352,0.033158891899939,0,0.966841108100061,0,227401.05382573
+0.046,0,631.927760430586,0.03313578370348,0,0.96686421629652,0,227348.130844786
+0.047,0,631.602384214019,0.033114473359066,0,0.966885526640935,0,227305.267773997
+0.048,0,631.304199612815,0.033094946914254,0,0.966905053085747,0,227270.395557991
+0.049,0,631.03159856009,0.033077172917165,0,0.966922827082835,0,227241.775254725
+0.05,0,630.782990369376,0.03306110532796,0,0.96693889467204,0,227217.936501855
+0.051,0,630.55678964989,0.033046685407581,0,0.96695331459242,0,227197.631713438
+0.052,0,630.35140498363,0.033033843025814,0,0.966966156974186,0,227179.799233795
+0.053,0,630.165233662095,0.033022497906864,0,0.966977502093137,0,227163.534448379
+0.054,0,629.997073759238,0.033012582089771,0,0.966987417910229,0,227148.298299695
+0.055,0,629.846302494884,0.033004054103933,0,0.966995945896067,0,227133.931609214
+0.056,0,629.712170405449,0.032996864959394,0,0.967003135040606,0,227120.21466138
+0.057,0,629.593837309956,0.032990957490394,0,0.967009042509606,0,227106.924467306
+0.058,0,629.490446034948,0.032986270020472,0,0.967013729979528,0,227093.872281717
+0.059,0,629.401399439643,0.03298277042371,0,0.96701722957629,0,227080.70275426
+0.06,0,629.32684639228,0.032980510509296,0,0.967019489490705,0,227066.644067621
+0.061,0,629.267350091974,0.032979572283525,0,0.967020427716475,0,227050.96979416
+0.062,0,629.22379425874,0.0329800586806,0,0.967019941319401,0,227033.024401883
+0.063,0,629.197351031518,0.03298209129193,0,0.96701790870807,0,227012.215407283
+0.064,0,629.189376381869,0.032985799821673,0,0.967014200178327,0,226988.052833517
+0.065,0,629.20136093888,0.032991320033654,0,0.967008679966346,0,226960.11628646
+0.066,0,629.235364358939,0.032998844866164,0,0.967001155133836,0,226927.743892892
+0.067,0,629.291440141115,0.033008317155933,0,0.966991682844068,0,226891.955132605
+0.068,0,629.367616076258,0.03301948039641,0,0.96698051960359,0,226854.557175523
+0.069,0,629.461002112308,0.033032019984255,0,0.966967980015746,0,226817.162518714
+0.07,0,629.568571942442,0.033045641058632,0,0.966954358941368,0,226780.866197995
+0.071,0,629.687583461566,0.033060099696145,0,0.966939900303855,0,226746.256932595
+0.072,0,629.815742372435,0.03307520807009,0,0.96692479192991,0,226713.544022754
+0.073,0,629.951211554238,0.03309082726535,0,0.96690917273465,0,226682.696047685
+0.074,0,630.092556406548,0.033106856972304,0,0.966893143027696,0,226653.549125814
+0.075,0,630.238473493265,0.033123193641129,0,0.966876806358871,0,226626.112318159
+0.076,0,630.387236541818,0.033139661727307,0,0.966860338272694,0,226600.886046499
+0.077,0,630.537898231681,0.033156207469039,0,0.966843792530961,0,226577.48251446
+0.078,0,630.689791395748,0.033172798089732,0,0.966827201910268,0,226555.550267599
+0.079,0,630.842377976037,0.033189406659447,0,0.966810593340553,0,226534.810490035
+0.08,0,630.995215573052,0.033206010694131,0,0.966793989305869,0,226515.03659967
+0.081,0,631.147941049368,0.033222591445093,0,0.966777408554907,0,226496.045366241
+0.082,0,631.300255758924,0.033239133227915,0,0.966760866772085,0,226477.688950423
+0.083,0,631.451914127925,0.033255622899719,0,0.966744377100281,0,226459.84865197
+0.084,0,631.602712622108,0.033272049333187,0,0.966727950666814,0,226442.429000389
+0.085,0,631.752481477103,0.033288403023578,0,0.966711596976422,0,226425.353244695
+0.086,0,631.901078005955,0.033304675768708,0,0.966695324231292,0,226408.559691637
+0.087,0,632.048381342424,0.033320860418436,0,0.966679139581564,0,226391.998792304
+0.088,0,632.194288311748,0.033336950679475,0,0.966663049320525,0,226375.630813599
+0.089,0,632.338710173438,0.033352940963111,0,0.966647059036889,0,226359.423965992
+0.09,0,632.48157003472,0.033368826265764,0,0.966631173734236,0,226343.35288923
+0.091,0,632.622800779467,0.033384602074548,0,0.966615397925452,0,226327.397421337
+0.092,0,632.762343393573,0.033400264291951,0,0.966599735708049,0,226311.541593725
+0.093,0,632.900145593184,0.033415809175272,0,0.966584190824729,0,226295.77280755
+0.094,0,633.036160674848,0.033431233287798,0,0.966568766712202,0,226280.081154204
+0.095,0,633.170346493028,0.033446533460142,0,0.966553466539858,0,226264.458843848
+0.096,0.006501914305388,1350.37452183033,0.077669798513563,0,0.922330201486437,1.28153913379326,568939.8840699
+0.097,0.056476703831833,1348.22158682032,0.077669798513563,0,0.922330201486437,1.28164628058425,565790.583306386
+0.098,0.155040003998106,1346.0394416705,0.077669798513563,0,0.922330201486437,1.28175515655154,562596.566334695
+0.099,0.301174242145517,1343.79195482806,0.077669798513563,0,0.922330201486437,1.28186758353779,559289.305275455
+0.1,0.493635912954106,1341.44390974981,0.077669798513563,0,0.922330201486437,1.28198535709822,555803.328992345
+0.101,0.730911008808371,1338.96110113649,0.077669798513563,0,0.922330201486437,1.28211024291527,552076.512732163
+0.102,1.01117556067672,1336.31044050267,0.077669798513563,0,0.922330201486437,1.28224397331397,548050.433650252
+0.103,1.33226241383186,1333.46007026744,0.077669798513563,0,0.922330201486437,1.28238824383663,543670.779493996
+0.104,1.69163539730422,1330.37948531618,0.077669798513563,0,0.922330201486437,1.28254470983816,538887.796682515
+0.105,2.08637202688263,1327.0396607794,0.077669798513563,0,0.922330201486437,1.28271498306378,533656.762555721
+0.106,2.51315580058998,1323.41318451841,0.077669798513563,0,0.922330201486437,1.28290062817524,527938.464886925
+0.107,2.96827899973252,1319.47439258439,0.077669798513563,0,0.922330201486437,1.28310315919467,521699.670786721
+0.108,3.44765670394878,1315.1995058859,0.077669798513563,0,0.922330201486437,1.28332403582998,514913.567671502
+0.109,3.94685242653361,1310.56676552434,0.077669798513563,0,0.922330201486437,1.28356465967998,507560.154135377
+0.11,4.46111548668965,1305.55656517213,0.077669798513563,0,0.922330201486437,1.28382637026745,499626.567518086
+0.111,4.98542984807425,1300.15157827866,0.077669798513563,0,0.922330201486437,1.28411044087663,491107.331151529
+0.112,5.51457348708983,1294.33687413592,0.077669798513563,0,0.922330201486437,1.28441807437257,482004.482790415
+0.113,6.0431877817761,1288.10003022584,0.077669798513563,0,0.922330201486437,1.28475039847911,472327.636354882
+0.114,6.56585431410019,1281.43122218513,0.077669798513563,0,0.922330201486437,1.28510846137716,462093.861127525
+0.115,7.07717831633517,1274.32330701232,0.077669798513563,0,0.922330201486437,1.28549322668583,451327.48759904
+0.116,7.57187555148476,1266.77188357294,0.077669798513563,0,0.922330201486437,1.28590556857646,440059.750771153
+0.117,8.04486033166119,1258.77533244291,0.077669798513563,0,0.922330201486437,1.28634626684314,428328.304383648
+0.118,8.49133286357763,1250.33484457296,0.077669798513563,0,0.922330201486437,1.2868160013484,416176.659705297
+0.119,8.90225886681827,1241.19052025582,0.077669798513563,0,0.922330201486437,1.28691311490079,403711.173741741
+0.12,9.26273884769235,1231.58849136839,0.077669798513563,0,0.922330201486437,1.28694149666362,390948.863226328
+0.121,9.56354039805257,1221.60753734497,0.077669798513563,0,0.922330201486437,1.28697003143505,377957.583309165
+0.122,9.79537576925132,1211.28824868696,0.077669798513563,0,0.922330201486437,1.28699876535004,364824.2950358
+0.123,9.94888003399992,1200.6817014443,0.077669798513563,0,0.922330201486437,1.28702774863178,351644.443070081
+0.124,10.0147370597951,1189.85064626486,0.077669798513563,0,0.922330201486437,1.28705703956365,338521.306893914
+0.125,9.98382811630515,1178.87070067414,0.077669798513563,0,0.922330201486437,1.28708670837843,325565.174783735
+0.126,9.84740941948793,1167.83149039393,0.077669798513563,0,0.922330201486437,1.28711685135643,312892.371510346
+0.127,9.5973841088826,1156.83760984891,0.077669798513563,0,0.922330201486437,1.28714771050486,300624.066218486
+0.128,9.02488527813066,1146.06571423167,0.077669798513563,0,0.922330201486437,1.28717966191702,288948.120221568
+0.129,8.23831759508816,1135.90650250732,0.077669798513563,0,0.922330201486437,1.28721377654743,278263.218890129
+0.13,7.43570999899277,1126.45410476439,0.077669798513563,0,0.922330201486437,1.28724966727416,268610.876145613
+0.131,6.61728827272689,1117.75807000481,0.077669798513563,0,0.922330201486437,1.28728696594435,259981.776493072
+0.132,5.78304075021765,1109.86742630418,0.077669798513563,0,0.922330201486437,1.28732545297652,252367.528356211
+0.133,4.93243985557763,1102.83021331119,0.077669798513563,0,0.922330201486437,1.28736499098864,245761.273590384
+0.134,4.06508091515051,1096.69992828717,0.077669798513563,0,0.922330201486437,1.28740551325717,240165.103052245
+0.135,3.20058055955674,1091.62490950022,0.077669798513563,0,0.922330201486437,1.28744695401585,235676.976958135
+0.136,2.35246679513232,1087.6418932803,0.077669798513563,0,0.922330201486437,1.287489119274,232289.663598135
+0.137,1.47140236135021,1084.58901561701,0.077669798513563,0,0.922330201486437,1.28753200386377,229813.632906397
+0.138,0.994299070121107,1083.08062563403,0.077669798513563,0,0.922330201486437,1.28757484512877,228812.255513332
+0.139,0.867616461933203,1082.26030863157,0.077669798513563,0,0.922330201486437,1.28761611746866,228463.292178899
+0.14,0.915133343021928,1081.7007874072,0.077669798513563,0,0.922330201486437,1.28765523268615,228360.192481313
+0.141,1.03720723241594,1081.28250839874,0.077669798513563,0,0.922330201486437,1.28769230353081,228389.427120375
+0.142,1.19034293163507,1080.96448083711,0.077669798513563,0,0.922330201486437,1.28772764637251,228512.266847615
+0.143,1.35569318415873,1080.72535422092,0.077669798513563,0,0.922330201486437,1.28776157918795,228708.787401048
+0.144,1.52418673523127,1080.54962117756,0.077669798513563,0,0.922330201486437,1.28779437625233,228964.715738934
+0.145,1.69084936332797,1080.42387033582,0.077669798513563,0,0.922330201486437,1.28782626711571,229267.8145945
+0.146,1.85260146739057,1080.33558109301,0.077669798513563,0,0.922330201486437,1.28785744505226,229606.681213429
+0.147,2.00737646427484,1080.27286875404,0.077669798513563,0,0.922330201486437,1.28788807314793,229970.451606228
+0.148,2.15370384440489,1080.22447808078,0.077669798513563,0,0.922330201486437,1.2879182879319,230348.747054194
+0.149,2.2904858521502,1080.17983798687,0.077669798513563,0,0.922330201486437,1.28794820125099,230731.686167942
+0.15,2.41685722448771,1080.12908904333,0.077669798513563,0,0.922330201486437,1.28797790122946,231109.878522644
+0.151,2.53209448539437,1080.06309530763,0.077669798513563,0,0.922330201486437,1.28800745273714,231474.409801595
+0.152,2.6355722136185,1079.97350925831,0.077669798513563,0,0.922330201486437,1.28803689774576,231816.883628291
+0.153,2.73241605979049,1079.87462521817,0.077669798513563,0,0.922330201486437,1.28806625484821,232150.556123893
+0.154,2.82544019709929,1079.77478817007,0.077669798513563,0,0.922330201486437,1.28809553194286,232483.355262739
+0.155,2.91353549692718,1079.66774300181,0.077669798513563,0,0.922330201486437,1.2881247436395,232809.256781135
+0.156,2.99621954305845,1079.54940578727,0.077669798513563,0,0.922330201486437,1.28815390590487,233124.297690466
+0.157,3.07338201257891,1079.41723320822,0.077669798513563,0,0.922330201486437,1.28818303251673,233425.982316157
+0.158,3.14517260747817,1079.26983518857,0.077669798513563,0,0.922330201486437,1.28821214255622,233712.91899697
+0.159,3.2119832940826,1079.10664385811,0.077669798513563,0,0.922330201486437,1.28824128574389,233984.508936389
+0.16,3.27428925700228,1078.92771521712,0.077669798513563,0,0.922330201486437,1.28827051317904,234240.757195224
+0.161,3.33260018759952,1078.73360678127,0.077669798513563,0,0.922330201486437,1.28829987063253,234482.157167545
+0.162,3.38743196843757,1078.52520831341,0.077669798513563,0,0.922330201486437,1.28832939972003,234709.528987585
+0.163,3.43926766364518,1078.30355655096,0.077669798513563,0,0.922330201486437,1.28835913598723,234923.840616217
+0.164,3.488495008545,1078.0695318245,0.077669798513563,0,0.922330201486437,1.28838910641653,235125.913080134
+0.165,3.53538083684346,1077.82321447456,0.077669798513563,0,0.922330201486437,1.2884193612353,235315.794540139
+0.166,3.57968521068245,1077.56361188431,0.077669798513563,0,0.922330201486437,1.28844985798112,235492.484204092
+0.167,3.62108275679904,1077.29039390297,0.077669798513563,0,0.922330201486437,1.28848047687893,235655.621794569
+0.168,3.65942710444785,1077.00401447205,0.077669798513563,0,0.922330201486437,1.28851110322431,235805.613782186
+0.169,3.69473952681296,1076.70531078724,0.077669798513563,0,0.922330201486437,1.28854165484634,235943.24612644
+0.17,3.72715635585147,1076.3952340121,0.077669798513563,0,0.922330201486437,1.28857208515397,236069.422175899
+0.171,3.75687424699311,1076.07470279944,0.077669798513563,0,0.922330201486437,1.2886023753713,236185.018940973
+0.172,3.78411138146272,1075.74454693571,0.077669798513563,0,0.922330201486437,1.28863252496167,236290.83097408
+0.173,3.80908335832242,1075.40549208938,0.077669798513563,0,0.922330201486437,1.28866254375047,236387.554485808
+0.174,3.83197520642757,1075.05818793311,0.077669798513563,0,0.922330201486437,1.28869243920442,236475.813794292
+0.175,3.85284091713715,1074.70328359108,0.077669798513563,0,0.922330201486437,1.28872217319718,236556.232893238
+0.176,3.87187746360859,1074.34138821632,0.077669798513563,0,0.922330201486437,1.28875176514301,236629.401552264
+0.177,3.88919745508298,1073.97260318164,0.077669798513563,0,0.922330201486437,1.28878124064407,236695.413470294
+0.178,3.9047794789777,1073.5964077292,0.077669798513563,0,0.922330201486437,1.28881061988769,236753.752107894
+0.179,3.91869747986604,1073.21286509383,0.077669798513563,0,0.922330201486437,1.28883991931865,236804.474465752
+0.18,3.93108965929776,1072.82245029532,0.077669798513563,0,0.922330201486437,1.28886915230766,236848.043434837
+0.181,3.94211346812288,1072.42579827627,0.077669798513563,0,0.922330201486437,1.28889832972523,236885.081179452
+0.182,3.95192107024551,1072.02356051706,0.077669798513563,0,0.922330201486437,1.2889274604449,236916.22856249
+0.183,3.96065160705669,1071.61635313108,0.077669798513563,0,0.922330201486437,1.28895655177941,236942.094302031
+0.184,3.96842596720143,1071.20472012003,0.077669798513563,0,0.922330201486437,1.28898560982798,236963.219048356
+0.185,3.97534879222613,1070.78913730827,0.077669798513563,0,0.922330201486437,1.28901463978025,236980.079645887
+0.186,3.98151001747729,1070.37001493151,0.077669798513563,0,0.922330201486437,1.28904364617958,236993.092367568
+0.187,3.986985819744,1069.94769758575,0.077669798513563,0,0.922330201486437,1.28907263317478,237002.614004515
+0.188,3.99184345499605,1069.52248567026,0.077669798513563,0,0.922330201486437,1.28910160478531,237008.964919066
+0.189,3.9961401228732,1069.09462335655,0.077669798513563,0,0.922330201486437,1.28913056522808,237012.420432081
+0.19,3.99992480742115,1068.66430080435,0.077669798513563,0,0.922330201486437,1.2891595193901,237013.218729664
+0.191,4.00324051826223,1068.23165386117,0.077669798513563,0,0.922330201486437,1.28918847361464,237011.571332403
+0.192,4.00612561757262,1067.79674756949,0.077669798513563,0,0.922330201486437,1.28921743721142,237007.668911801
+0.193,4.00861227296979,1067.35951393738,0.077669798513563,0,0.922330201486437,1.28924642589539,237001.671294469
+0.194,4.01073115089133,1066.91962885451,0.077669798513563,0,0.922330201486437,1.28927547134447,236993.730669796
+0.195,4.01250537476689,1066.4759235868,0.077669798513563,0,0.922330201486437,1.28930465672647,236983.974111017
+0.196,4.01371163772525,1066.02153253151,0.077669798513563,0,0.922330201486437,1.28933433461055,236972.603870266
+0.197,7.73495335103711,314.339827483569,0.010348419742401,0,0.989651580257599,1.39790040519366,237939.126719448
+0.198,7.94971303398093,314.577660087958,0.010348419742401,0,0.989651580257599,1.39790113553844,238535.688589108
+0.199,8.03474149893783,314.675282375711,0.010348419742401,0,0.989651580257599,1.39790140113623,238760.00640874
+0.2,8.07859560712965,314.731989561442,0.010348419742401,0,0.989651580257599,1.39790132426134,238875.680989326
+0.201,8.10709338244629,314.777286459071,0.010348419742401,0,0.989651580257599,1.39790095424842,238961.181941989
+0.202,8.12746745587666,314.819330012023,0.010348419742401,0,0.989651580257599,1.3979003118067,239038.213268517
+0.203,8.14180364564858,314.860369587863,0.010348419742401,0,0.989651580257599,1.39789940638296,239112.758996188
+0.204,8.15077609592651,314.9010540871,0.010348419742401,0,0.989651580257599,1.39789824349411,239186.543222561
+0.205,8.15467836010095,314.941605232535,0.010348419742401,0,0.989651580257599,1.39789682780207,239260.152907331
+0.206,8.15370298678782,314.982118950129,0.010348419742401,0,0.989651580257599,1.3978951646762,239333.839977926
+0.207,8.14803132837544,315.022655251703,0.010348419742401,0,0.989651580257599,1.3978932609655,239407.76054141
+0.208,8.13786070874762,315.063259561171,0.010348419742401,0,0.989651580257599,1.39789112543123,239482.031590511
+0.209,8.12341503596851,315.103968069552,0.010348419742401,0,0.989651580257599,1.39788876898838,239556.745216935
+0.21,8.1049510415062,315.144809215012,0.010348419742401,0,0.989651580257599,1.39788620487093,239631.972521861
+0.211,8.08276127929245,315.185803501855,0.010348419742401,0,0.989651580257599,1.39788344868671,239707.763131079
+0.212,8.0571776272649,315.226963865595,0.010348419742401,0,0.989651580257599,1.39788051846175,239784.146169283
+0.213,8.02856884797779,315.268291984095,0.010348419742401,0,0.989651580257599,1.39787743454366,239861.120454342
+0.214,7.9973471076755,315.309785546912,0.010348419742401,0,0.989651580257599,1.39787421949495,239938.673951456
+0.215,7.96396286962991,315.351433242592,0.010348419742401,0,0.989651580257599,1.39787089791023,240016.770467321
+0.216,7.92890112337347,315.393213253762,0.010348419742401,0,0.989651580257599,1.39786749616535,240095.345720186
+0.217,7.89267777602661,315.435093790026,0.010348419742401,0,0.989651580257599,1.39786404210565,240174.308874655
+0.218,7.8558560618733,315.477033033069,0.010348419742401,0,0.989651580257599,1.39786056575103,240253.542299792
+0.219,7.8192156397161,315.518972522374,0.010348419742401,0,0.989651580257599,1.39785710763601,240332.882177686
+0.22,7.78366026515695,315.560824270875,0.010348419742401,0,0.989651580257599,1.39785371460644,240412.085132821
+0.221,7.75014100048055,315.602478510964,0.010348419742401,0,0.989651580257599,1.39785043571422,240490.849982645
+0.222,7.71965523874488,315.643806123111,0.010348419742401,0,0.989651580257599,1.39784732212875,240568.824487583
+0.223,7.69323087428763,315.684655169043,0.010348419742401,0,0.989651580257599,1.39784442667242,240645.596533536
+0.224,7.67190895084169,315.724856169188,0.010348419742401,0,0.989651580257599,1.39784180302971,240720.708963471
+0.225,7.6567131729187,315.764215550912,0.010348419742401,0,0.989651580257599,1.39783950493317,240793.643065741
+0.226,7.64914685450442,315.80249978729,0.010348419742401,0,0.989651580257599,1.3978376106211,240863.772269381
+0.227,7.65073478492489,315.83942644773,0.010348419742401,0,0.989651580257599,1.39783620220328,240930.344967444
+0.228,7.66734993822141,315.874473913152,0.010348419742401,0,0.989651580257599,1.39783557838868,240991.934415594
+0.229,7.69705649676959,315.90711553242,0.010348419742401,0,0.989651580257599,1.39783567506626,241047.197219342
+0.23,7.73675757321245,315.937194847016,0.010348419742401,0,0.989651580257599,1.39783635999735,241095.826450691
+0.231,7.78422520240497,315.964630118595,0.010348419742401,0,0.989651580257599,1.39783753862499,241137.76810203
+0.232,7.83768475093179,315.989284375015,0.010348419742401,0,0.989651580257599,1.39783913895945,241172.951775471
+0.233,7.89574522729327,316.010845645344,0.010348419742401,0,0.989651580257599,1.39784111261164,241201.213961614
+0.234,7.95694626520455,316.028011700505,0.010348419742401,0,0.989651580257599,1.39784344448062,241221.395962656
+0.235,7.94180832152414,322.053966890463,0.010416728950621,0,0.98958327104938,1.3975807562545,241224.794581727
+0.236,7.99830137527126,321.984092939307,0.010412153810637,0,0.989587846189363,1.39758868053952,241202.511739142
+0.237,8.05214747560184,321.910084427713,0.010407616603983,0,0.989592383396017,1.39759664680055,241167.270804844
+0.238,8.09434060664939,321.830372205841,0.010403131181616,0,0.989596868818385,1.39760421422827,241114.466681875
+0.239,8.12168017835024,321.744868027969,0.010398706899113,0,0.989601293100887,1.39761119326474,241043.508087942
+0.24,8.13471280578782,321.653821610298,0.010394351709194,0,0.989605648290806,1.3976175918185,240954.707079921
+0.241,8.13494537008183,321.557435986104,0.010390072830547,0,0.989609927169453,1.39762347912139,240848.269856829
+0.242,8.12377099779949,321.455813705967,0.010385876835262,0,0.989614123164738,1.39762892680171,240724.163205827
+0.243,8.10225283712497,321.348977639387,0.010381769738223,0,0.989618230261777,1.39763399447907,240582.167988663
+0.244,8.07114305976381,321.236882620444,0.010377757177774,0,0.989622242822226,1.39763872943051,240421.902610746
+0.245,8.03093592944382,321.119416398268,0.010373844624387,0,0.989626155375613,1.39764316904239,240242.81713942
+0.246,7.98190136539178,320.996388753932,0.010370037617779,0,0.989629962382221,1.39764734296394,240044.155945468
+0.247,7.92409745034664,320.867515007481,0.010366342007333,0,0.989633657992667,1.39765127455148,239824.906351047
+0.248,7.85736273777305,320.732390876998,0.010362764227734,0,0.989637235772266,1.39765498177437,239583.724599399
+0.249,7.78130127706978,320.590470343127,0.01035931156474,0,0.989640688435261,1.39765847782517,239318.871566159
+0.25,7.69524349341095,320.44102583249,0.010355992513028,0,0.989644007486972,1.39766177146331,239028.101402206
+0.251,7.59820007726397,320.283110635326,0.010352817144375,0,0.989647182855625,1.39766486728955,238708.558881692
+0.252,7.48877255226523,320.115514414064,0.010349797542861,0,0.98965020245714,1.39766776462791,238356.661270585
+0.253,7.36497095487668,319.936719901442,0.010346948313679,0,0.989653051686322,1.39767045263871,237967.987883661
+0.254,7.22441623993849,319.74504785868,0.010344286158427,0,0.989655713841573,1.39767291808959,237537.685988953
+0.255,7.06508824331721,319.539502040241,0.010341825616265,0,0.989658174383735,1.39767515012605,237062.777772378
+0.256,6.88459049383028,319.319056291785,0.010339582762664,0,0.989660417237336,1.39767713627428,236540.212547004
+0.257,6.67972501539387,319.08233047612,0.01033757728356,0,0.98966242271644,1.39767886174093,235965.998989189
+0.258,6.44649232444219,318.827657306412,0.010335832661169,0,0.989664167338831,1.39768031606972,235335.40992856
+0.259,6.17977936843936,318.553174678918,0.010334376319837,0,0.989665623680163,1.39768148870069,234643.266269048
+0.26,5.87388343723664,318.257762607443,0.010333235521824,0,0.989666764478176,1.3976823701541,233886.5489895
+0.261,5.52425996570161,317.942849443807,0.010332427982151,0,0.98966757201785,1.3976829616791,233069.367164434
+0.262,5.129543686664,317.613949404705,0.010331953194823,0,0.989668046805177,1.39768328257759,232207.061405785
+0.263,4.69058993851628,317.279080043654,0.010331775885014,0,0.989668224114987,1.39768338222625,231322.347694882
+0.264,4.18240382934936,316.929137352104,0.010331766100881,0,0.989668233899119,1.39768339042915,230396.134170296
+0.265,3.70079173188366,316.633285548236,0.010331766100881,0,0.989668233899119,1.39768343946054,229609.251529402
+0.266,3.30011421638345,316.41369171395,0.010331766100881,0,0.989668233899119,1.39768351494433,229017.570491298
+0.267,2.99432374495971,316.262335272172,0.010331766100881,0,0.989668233899119,1.39768359373804,228599.921941643
+0.268,2.77548095663382,316.162742021521,0.010331766100881,0,0.989668233899119,1.3976836580253,228313.99373399
+0.269,2.62716384733918,316.099610021575,0.010331766100881,0,0.989668233899119,1.39768369699213,228120.710637099
+0.27,2.53223205857679,316.061427089963,0.010331766100881,0,0.989668233899119,1.39768370589409,227990.756643452
+0.271,2.47608373216326,316.040214764725,0.010331766100881,0,0.989668233899119,1.39768368423429,227903.847510757
+0.272,2.44746979981057,316.030621763258,0.010331766100881,0,0.989668233899119,1.39768363406068,227846.392414713
+0.273,2.43813853831318,316.029077896812,0.010331766100881,0,0.989668233899119,1.39768355827703,227809.330558371
+0.274,2.44153305794423,316.033207080467,0.010331766100881,0,0.989668233899119,1.39768344878197,227786.636645258
+0.275,2.45376312439261,316.041501186572,0.010331766100881,0,0.989668233899119,1.39768330731067,227774.486886889
+0.276,2.47240031211694,316.052920476061,0.010331766100881,0,0.989668233899119,1.39768314018032,227770.245358621
+0.277,2.49570055238711,316.066723728234,0.010331766100881,0,0.989668233899119,1.39768295223368,227772.033645671
+0.278,2.52242811821874,316.082379380244,0.010331766100881,0,0.989668233899119,1.39768274740438,227778.50514742
+0.279,2.55170376748746,316.099502133996,0.010331766100881,0,0.989668233899119,1.39768252888488,227788.684200325
+0.28,2.58289798447871,316.11781006752,0.010331766100881,0,0.989668233899119,1.39768229925248,227801.85727628
+0.281,2.61555704232824,316.1370950974,0.010331766100881,0,0.989668233899119,1.39768206058456,227817.498070956
+0.282,2.64935084912173,316.157202078815,0.010331766100881,0,0.989668233899119,1.39768181455648,227835.214509318
+0.283,2.68403766495902,316.178014606376,0.010331766100881,0,0.989668233899119,1.39768156251882,227854.712749636
+0.284,2.71943862389454,316.199444574516,0.010331766100881,0,0.989668233899119,1.39768130556135,227875.770721665
+0.285,2.75541982234429,316.221424693088,0.010331766100881,0,0.989668233899119,1.39768104456432,227898.219157097
+0.286,2.79188011211492,316.243903292116,0.010331766100881,0,0.989668233899119,1.39768078023842,227921.928424722
+0.287,2.82874212181354,316.266840388125,0.010331766100881,0,0.989668233899119,1.39768051315753,227946.79856217
+0.288,2.8659458656613,316.290204799604,0.010331766100881,0,0.989668233899119,1.39768024378509,227972.751966396
+0.289,2.90344423527713,316.313972053889,0.010331766100881,0,0.989668233899119,1.39767997249504,227999.728090161
+0.29,2.94119985040058,316.338122875891,0.010331766100881,0,0.989668233899119,1.39767969958867,228027.679613077
+0.291,2.97918238645163,316.362641826911,0.010331766100881,0,0.989668233899119,1.39767942531033,228056.568990296
+0.292,3.01736706521588,316.387516535967,0.010331766100881,0,0.989668233899119,1.39767914985774,228086.366505704
+0.293,3.05573323894518,316.412736933582,0.010331766100881,0,0.989668233899119,1.39767887339201,228117.048328563
+0.294,3.09426264184672,316.438294629406,0.010331766100881,0,0.989668233899119,1.39767859603325,228148.594936895
+0.295,3.1320318483721,316.464124455399,0.010331766100881,0,0.989668233899119,1.3976783021198,228180.845371506
+0.296,3.21901491391031,316.494169027604,0.010331766100881,0,0.989668233899119,1.39767884886577,228223.661582347
+0.297,3.30613536610988,316.515454345072,0.010331766100881,0,0.989668233899119,1.39767980591886,228244.27515563
+0.298,3.34953114756805,316.528648535027,0.010331766100881,0,0.989668233899119,1.39768020105002,228244.50522401
+0.299,3.37169250760164,316.540544353449,0.010331766100881,0,0.989668233899119,1.39768020245391,228241.514929748
+0.3,3.38255269434338,316.554549545733,0.010331766100881,0,0.989668233899119,1.39767987609348,228243.916751989
+0.301,3.38702210130629,316.57253775831,0.010331766100881,0,0.989668233899119,1.39767924921504,228256.448013335
+0.302,3.3877788281363,316.595615363857,0.010331766100881,0,0.989668233899119,1.39767833396184,228281.908819589
+0.303,3.38643390442389,316.62447014651,0.010331766100881,0,0.989668233899119,1.3976771369253,228322.043570922
+0.304,3.38405932961852,316.659539727207,0.010331766100881,0,0.989668233899119,1.3976756632884,228377.966859058
+0.305,3.38144255326804,316.701096450378,0.010331766100881,0,0.989668233899119,1.39767391874882,228450.378123427
+0.306,3.37921587636077,316.749291852434,0.010331766100881,0,0.989668233899119,1.39767191047774,228539.674031115
+0.307,3.37792497030949,316.804180458543,0.010331766100881,0,0.989668233899119,1.39766964764122,228646.008483655
+0.308,3.37806511019341,316.865732543403,0.010331766100881,0,0.989668233899119,1.39766714169333,228769.324602049
+0.309,3.38010190845518,316.933841026444,0.010331766100881,0,0.989668233899119,1.39766440658854,228909.371763304
+0.31,3.38447803525974,317.008325148353,0.010331766100881,0,0.989668233899119,1.39766145883642,229065.714374245
+0.311,3.39161615148627,317.08893264726,0.010331766100881,0,0.989668233899119,1.39765831754833,229237.736745819
+0.312,3.40191633512729,317.175342000754,0.010331766100881,0,0.989668233899119,1.39765500437268,229424.648033871
+0.313,3.41575035026332,317.267164038807,0.010331766100881,0,0.989668233899119,1.39765154339431,229625.485520802
+0.314,3.4334540235842,317.363945110716,0.010331766100881,0,0.989668233899119,1.39764796093004,229839.121777843
+0.315,3.45531947557218,317.465171217637,0.010331766100881,0,0.989668233899119,1.39764428527537,230064.274265541
+0.316,3.48158535468952,317.570272245163,0.010331766100881,0,0.989668233899119,1.39764054638911,230299.515213513
+0.317,3.51245286425615,317.678631450038,0.010331766100881,0,0.989668233899119,1.39763677591656,230543.294851156
+0.318,3.54848444754375,317.789614891511,0.010331766100881,0,0.989668233899119,1.39763301507349,230794.014625308
+0.319,3.59040012640668,317.902487447042,0.010331766100881,0,0.989668233899119,1.39762931400585,231049.812770963
+0.32,3.63871808242632,318.016377355039,0.010331766100881,0,0.989668233899119,1.39762572538157,231308.473448554
+0.321,3.69379407498245,318.130303164953,0.010331766100881,0,0.989668233899119,1.39762230419249,231567.494090591
+0.322,3.75583730194833,318.243192491492,0.010331766100881,0,0.989668233899119,1.39761910730495,231824.132264553
+0.323,3.8249133971273,318.353897695875,0.010331766100881,0,0.989668233899119,1.39761619275754,232075.445078522
+0.324,3.90092197108172,318.461204634033,0.010331766100881,0,0.989668233899119,1.39761361861369,232318.311224105
+0.325,3.86163806410798,318.575147282373,0.010331766100881,0,0.989668233899119,1.39761146068875,232578.472782635
+0.326,3.83193370323584,318.709841842381,0.010331766100881,0,0.989668233899119,1.39760979822414,232892.292810771
+0.327,3.82725616143167,318.859488006916,0.010331766100881,0,0.989668233899119,1.3976089323144,233245.03517533
+0.328,3.82795627655497,319.015920756046,0.010331766100881,0,0.989668233899119,1.39760888378538,233615.838768073
+0.329,3.81520235234318,319.171417097433,0.010331766100881,0,0.989668233899119,1.39760949653895,233984.827587337
+0.33,3.78376296999068,319.324917038992,0.010331766100881,0,0.989668233899119,1.39761065692649,234349.108202881
+0.331,3.74493482700316,319.491454486819,0.010331766100881,0,0.989668233899119,1.39761227758078,234747.418236933
+0.332,3.69626858399809,319.67353371867,0.010331766100881,0,0.989668233899119,1.39761429179426,235186.366581756
+0.333,3.63583825639441,319.873243246145,0.010331766100881,0,0.989668233899119,1.39761664877862,235671.530309982
+0.334,3.56223571170423,320.092965843314,0.010331766100881,0,0.989668233899119,1.39761928296601,236209.302402228
+0.335,3.47495224656598,320.335346616863,0.010331766100881,0,0.989668233899119,1.39762214668616,236806.817075588
+0.336,3.37376525071949,320.603038636947,0.010331766100881,0,0.989668233899119,1.39762518911488,237471.309371558
+0.337,3.25538776482404,320.899135026759,0.010331766100881,0,0.989668233899119,1.39762798032961,238211.328835421
+0.338,3.12035285769051,321.227067344056,0.010331766100881,0,0.989668233899119,1.39763028159918,239036.397110407
+0.339,2.97143332539274,321.590014811401,0.010331766100881,0,0.989668233899119,1.39763208082517,239955.48076506
+0.34,2.81147901110288,321.990708759549,0.010331766100881,0,0.989668233899119,1.39763344845243,240976.517152452
+0.341,2.64286534725958,322.431468120802,0.010331766100881,0,0.989668233899119,1.39763446408779,242106.526343018
+0.342,2.46759532189474,322.914262462866,0.010331766100881,0,0.989668233899119,1.39763519628061,243351.785638698
+0.343,2.28750276293116,323.440751263155,0.010331766100881,0,0.989668233899119,1.39763570071022,244717.936389887
+0.344,2.10441330372176,324.012289910653,0.010331766100881,0,0.989668233899119,1.3976360226432,246210.000399663
+0.345,1.92025091295244,324.629911745338,0.010331766100881,0,0.989668233899119,1.39763619944129,247832.329485505
+0.346,1.7371033678482,325.294294183503,0.010331766100881,0,0.989668233899119,1.39763626236145,249588.507918783
+0.347,1.55725948100401,326.005719504768,0.010331766100881,0,0.989668233899119,1.39763623772875,251481.230070091
+0.348,1.38322542496079,326.76402505339,0.010331766100881,0,0.989668233899119,1.39763614787772,253512.145078986
+0.349,1.2177255332402,327.568555922832,0.010331766100881,0,0.989668233899119,1.39763601175201,255681.691653316
+0.35,1.06369044774333,328.418113412582,0.010331766100881,0,0.989668233899119,1.39763584556604,257988.919308207
+0.351,0.924234316437575,329.310911424193,0.010331766100881,0,0.989668233899119,1.39763566260301,260431.306984492
+0.352,0.80262077293748,330.244533369775,0.010331766100881,0,0.989668233899119,1.39763546829832,263004.580710297
+0.353,0.702229360307422,331.215897459565,0.010331766100881,0,0.989668233899119,1.39763526554173,265702.534865813
+0.354,0.626509474669859,332.221228177967,0.010331766100881,0,0.989668233899119,1.39763505821763,268516.860790058
+0.355,0.578926152774,333.256036191496,0.010331766100881,0,0.989668233899119,1.39763484995473,271436.989318574
+0.356,0.557997610163343,334.31526897996,0.010331766100881,0,0.989668233899119,1.39763464415266,274450.417184499
+0.357,0.538799456502777,335.396610531179,0.010331766100881,0,0.989668233899119,1.39763444955337,277552.185456359
+0.358,0.517391322386103,336.500736307213,0.010331766100881,0,0.989668233899119,1.39763427854443,280745.91824885
+0.359,0.493820282202668,337.628448155989,0.010331766100881,0,0.989668233899119,1.3976341420816,284035.725201819
+0.36,0.468124757876227,338.780555025321,0.010331766100881,0,0.989668233899119,1.39763404997639,287425.857852419
+0.361,0.440335919275277,339.957875875403,0.010331766100881,0,0.989668233899119,1.39763401100511,290920.743531743
+0.362,0.410478570189754,341.161240047716,0.010331766100881,0,0.989668233899119,1.39763403166584,294524.976231601
+0.363,0.378572706016753,342.391490044992,0.010331766100881,0,0.989668233899119,1.39763412094621,298243.339885157
+0.364,0.344633127885758,343.649481290157,0.010331766100881,0,0.989668233899119,1.39763428145911,302080.818910774
+0.365,0.308668950784061,344.936079804541,0.010331766100881,0,0.989668233899119,1.39763448822528,306042.612693324
+0.366,0.270687400118586,346.252166737273,0.010331766100881,0,0.989668233899119,1.39763471177435,310134.148947837
+0.367,0.230694564780519,347.598640949224,0.010331766100881,0,0.989668233899119,1.39763492859142,314361.096796206
+0.368,0.188695035533096,348.976420483971,0.010331766100881,0,0.989668233899119,1.3976351237328,318729.380708321
+0.369,0.144691394002784,350.386443514318,0.010331766100881,0,0.989668233899119,1.39763528968478,323245.195620249
+0.37,0.098683893238367,351.829669132912,0.010331766100881,0,0.989668233899119,1.39763542410147,327915.023238091
+0.371,0.050670362163836,353.307078168581,0.010331766100881,0,0.989668233899119,1.39763552771711,332745.649460412
+0.372,0.000646263560199,354.819673852919,0.010331766100881,0,0.989668233899119,1.39763560282593,337744.182105325
+0.373,0,630.322672038246,0.0331305037203,0,0.966869496279701,0,226618.411585592
+0.374,0,630.472300763998,0.033147006997624,0,0.966852993002376,0,226593.92211152
+0.375,0,630.623555722443,0.033163574568338,0,0.966836425431662,0,226571.111947425
+0.376,0,630.775825873855,0.033180176204404,0,0.966819823795596,0,226549.661287838
+0.377,0,630.928611358701,0.033196786759967,0,0.966803213240033,0,226529.311897783
+0.378,0,631.081501308415,0.033213385240141,0,0.966786614759859,0,226509.854306626
+0.379,0,631.234158695835,0.033229954139759,0,0.966770045860241,0,226491.119535307
+0.38,0,631.38630659541,0.033246478817724,0,0.966753521182276,0,226472.971615794
+0.381,0,631.537716444458,0.033262946948486,0,0.966737053051514,0,226455.301224046
+0.382,0,631.688198409602,0.033279348065039,0,0.966720651934961,0,226438.020459427
+0.383,0,631.837593675156,0.033295673190601,0,0.966704326809399,0,226421.05864768
+0.384,0,631.985768351482,0.033311914547702,0,0.966688085452298,0,226404.358991836
+0.385,0,632.13260868595,0.033328065330739,0,0.966671934669261,0,226387.875899124
+0.386,0,632.278017293693,0.033344119528632,0,0.966655880471368,0,226371.572838315
+0.387,0,632.421910176359,0.033360071786172,0,0.966639928213828,0,226355.420612545
+0.388,0,632.564214347105,0.03337591729492,0,0.96662408270508,0,226339.395959444
+0.389,0,632.704865922008,0.033391651706653,0,0.966608348293347,0,226323.480411287
+0.39,0,632.843808569979,0.033407271064073,0,0.966592728935927,0,226307.659363198
+0.391,0,632.980992234243,0.033422771744984,0,0.966577228255016,0,226291.921307994
+0.392,0,633.116372044079,0.033438150417405,0,0.966561849582595,0,226276.257202024
+0.393,0,633.249907298909,0.033453404004855,0,0.966546595995145,0,226260.659922182
+0.394,0,633.382648752266,0.033468567182115,0,0.966531432817886,0,226245.664303218
+0.395,0,633.341289543066,0.033470874539387,0,0.966529125460614,0,226200.704138778
+0.396,0,632.80874098088,0.033435356926076,0,0.966564643073924,0,226098.211687369
+0.397,0,632.310135878701,0.03339988182813,0,0.96660011817187,0,226034.558176665
+0.398,0,631.848191453845,0.033365277391966,0,0.966634722608034,0,225997.045556472
+0.399,0,631.426649920893,0.033332019828844,0,0.966667980171156,0,225980.651832894
+0.4,0,631.049729083836,0.033300463224994,0,0.966699536775006,0,225983.319097062
+0.401,0,630.721673402995,0.0332709101337,0,0.9667290898663,0,226004.148836321
+0.402,0,630.44645630081,0.033243631858977,0,0.966756368141023,0,226042.676120229
+0.403,0,630.227596907787,0.033218873495231,0,0.966781126504769,0,226098.5637975
+0.404,0,630.068037139132,0.033196854210058,0,0.966803145789943,0,226171.460316186
+0.405,0,629.970055093481,0.033177765919728,0,0.966822234080272,0,226260.932072814
+0.406,0,629.935197218555,0.033161771434399,0,0.966838228565601,0,226366.426213452
+0.407,0,629.964225582831,0.033149002492504,0,0.966850997507496,0,226487.249903533
+0.408,0,630.057077033569,0.03313955789174,0,0.96686044210826,0,226622.556905608
+0.409,0,630.212836154179,0.033133501854056,0,0.966866498145945,0,226771.340325056
+0.41,0,630.42973724627,0.033130862957899,0,0.966869137042101,0,226932.441286225
+0.411,0,630.705140747316,0.033131632883001,0,0.966868367116999,0,227104.527227935
+0.412,0,631.03558656517,0.0331357665428,0,0.9668642334572,0,227286.123748445
+0.413,0,631.416819050531,0.033143182058723,0,0.966856817941277,0,227475.613061657
+0.414,0,631.843849912044,0.033153761647351,0,0.966846238352649,0,227671.252537555
+0.415,0,632.311031943526,0.033167352973624,0,0.966832647026376,0,227871.193577608
+0.416,0,632.812138214674,0.033183771033358,0,0.966816228966643,0,228073.500459361
+0.417,0,633.339623949113,0.033202775622822,0,0.966797224377178,0,228275.781761672
+0.418,0,633.884238444653,0.03322403209079,0,0.96677596790921,0,228474.975439358
+0.419,0,634.435935339083,0.03324713979363,0,0.96675286020637,0,228667.843078287
+0.42,0,634.983996248112,0.033271636670211,0,0.966728363329789,0,228851.003007971
+0.421,0,635.517158857561,0.033296999350496,0,0.966703000649504,0,229020.953389844
+0.422,0,636.023772681227,0.033322644025464,0,0.966677355974536,0,229174.115745031
+0.423,0,636.491977164828,0.033347928279712,0,0.966652071720289,0,229306.894995085
+0.424,0,636.9107093921,0.033372253644516,0,0.966627746355484,0,229415.081162388
+0.425,0,637.271084778608,0.033395182966015,0,0.966604817033985,0,229493.507838374
+0.426,0,637.540524461057,0.033414888228375,0,0.966585111771625,0,229527.862901586
+0.427,0,637.692609233249,0.033429567652922,0,0.966570432347078,0,229509.319448727
+0.428,0,637.736884376823,0.033439087150775,0,0.966560912849225,0,229448.225194653
+0.429,0,637.68139064974,0.033443381219015,0,0.966556618780985,0,229351.925454074
+0.43,0,637.53271909034,0.033442385319754,0,0.966557614680246,0,229226.070504289
+0.431,0,637.295997074405,0.033436013260254,0,0.966563986739746,0,229075.039999749
+0.432,0,636.975441026545,0.033424189838939,0,0.966575810161061,0,228902.165671648
+0.433,0,636.576543289108,0.033406952551783,0,0.966593047448218,0,228711.144531535
+0.434,0,636.11355353798,0.033384694499415,0,0.966615305500585,0,228506.23510562
+0.435,0,635.580978816711,0.033357139724371,0,0.966642860275629,0,228287.137375142
+0.436,0,635.020965830971,0.033326443512847,0,0.966673556487153,0,228078.487086574
+0.437,0,634.474599319677,0.033295019158355,0,0.966704980841645,0,227898.854112723
+0.438,0,633.959163146856,0.033264202558005,0,0.966735797441995,0,227751.106173656
+0.439,0,633.479025278301,0.033234621253216,0,0.966765378746784,0,227631.396394708
+0.44,0,633.033991313762,0.033206573924724,0,0.966793426075276,0,227534.725101597
+0.441,0,632.622600708037,0.033180210791824,0,0.966819789208176,0,227456.667876847
+0.442,0,632.243138101882,0.033155607786783,0,0.966844392213217,0,227393.614453786
+0.443,0,631.893888147898,0.033132797691707,0,0.966867202308293,0,227342.63675374
+0.444,0,631.5731801319,0.033111784560091,0,0.966888215439909,0,227301.328058034
+0.445,0,631.279383785686,0.033092551244725,0,0.966907448755275,0,227267.68223846
+0.446,0,631.010896887178,0.033075063734085,0,0.966924936265915,0,227240.010939637
+0.447,0,630.766132595011,0.033059273837109,0,0.966940726162891,0,227216.885380051
+0.448,0,630.543507499321,0.033045120943798,0,0.966954879056202,0,227197.092558597
+0.449,0,630.341430430723,0.033032533260223,0,0.966967466739777,0,227179.599525721
+0.45,0,630.158313513399,0.033021429819571,0,0.966978570180429,0,227163.534619496
+0.451,0,629.993101733392,0.033011749243301,0,0.966988250756699,0,227148.457622221
+0.452,0,629.845175281127,0.033003450241337,0,0.966996549758663,0,227134.209896853
+0.453,0,629.713765080813,0.032996482465923,0,0.967003517534077,0,227120.56495999
+0.454,0,629.598025676798,0.032990787883721,0,0.967009212116279,0,227107.304498758
+0.455,0,629.497108920215,0.032986305190637,0,0.967013694809363,0,227094.242525381
+0.456,0,629.41052494976,0.032983015059685,0,0.967016984940315,0,227080.95042246
+0.457,0,629.338512752567,0.032980977317814,0,0.967019022682186,0,227066.642134752
+0.458,0,629.281692549892,0.032980277687289,0,0.967019722312711,0,227050.60409145
+0.459,0,629.240999463571,0.03298102255042,0,0.96701897744958,0,227032.190144601
+0.46,0,629.217648380348,0.032983336049153,0,0.967016663950848,0,227010.820327895
+0.461,0,629.213010001288,0.032987347482719,0,0.967012652517281,0,226986.030646097
+0.462,0,629.228673672514,0.032993203468172,0,0.967006796531829,0,226957.342436227
+0.463,0,629.266577584147,0.033001078458939,0,0.966998921541061,0,226924.252921748
+0.464,0,629.326319189672,0.033010865093598,0,0.966989134906402,0,226888.049731124
+0.465,0,629.405693068621,0.033022288529966,0,0.966977711470034,0,226850.552013019
+0.466,0,629.501744396141,0.033035034154163,0,0.966964965845837,0,226813.288238633
+0.467,0,629.611471658285,0.033048814383929,0,0.966951185616071,0,226777.260443875
+0.468,0,629.732205330705,0.033063395292413,0,0.966936604707587,0,226742.980172878
+0.469,0,629.861732412897,0.033078598249571,0,0.966921401750429,0,226710.60514305
+0.47,0,629.998291616066,0.033094291900209,0,0.966905708099791,0,226680.07385453
+0.471,0,630.140510625244,0.033110381595828,0,0.966889618404172,0,226651.207584774
+0.472,0,630.287023248553,0.033126750252776,0,0.966873249747225,0,226624.132686184
+0.473,0,630.436171641361,0.033143234599377,0,0.966856765400623,0,226599.240799241
+0.474,0,630.587092389554,0.033159790308132,0,0.966840209691868,0,226576.106993084
+0.475,0,630.73914486547,0.033176385850201,0,0.966823614149799,0,226554.394061862
+0.476,0,630.89180842762,0.033192995133368,0,0.966807004866632,0,226533.832108422
+0.477,0,631.044654918157,0.033209596357222,0,0.966790403642779,0,226514.202051432
+0.478,0,631.197333192463,0.033226171349852,0,0.966773828650148,0,226495.327089604
+0.479,0,631.349554931598,0.03324270492784,0,0.96675729507216,0,226477.0649394
+0.48,0,631.501082446587,0.033259184329547,0,0.966740815670453,0,226459.301201954
+0.481,0,631.651718606828,0.033275598738734,0,0.966724401261266,0,226441.943900582
+0.482,0,631.801298749365,0.03329193889854,0,0.96670806110146,0,226424.919081186
+0.483,0,631.949684277513,0.033308196805663,0,0.966691803194337,0,226408.167300839
+0.484,0,632.096757627139,0.033324365470941,0,0.966675634529059,0,226391.640827271
+0.485,0,632.242418307651,0.033340438732699,0,0.966659561267301,0,226375.301396747
+0.486,0,632.386579774701,0.033356411110943,0,0.966643588889057,0,226359.11840891
+0.487,0,632.529166942893,0.033372277692825,0,0.966627722307175,0,226343.067465271
+0.488,0,632.670114190793,0.033388034041929,0,0.966611965958071,0,226327.129180203
+0.489,0,632.809363744571,0.033403676125787,0,0.966596323874213,0,226311.288209707
+0.49,0,632.946864349991,0.033419200257548,0,0.966580799742452,0,226295.532454717
+0.491,0,633.082570152144,0.033434603048968,0,0.966565396951032,0,226279.852402619
+0.492,0,633.216439679692,0.033449881373529,0,0.966550118626471,0,226264.240569582
+0.493,0,633.348926585382,0.033465049155912,0,0.966534950844088,0,226248.938513354
+0.494,0,633.44785622131,0.033477597909864,0,0.966522402090136,0,226229.149728995
+0.495,0,632.908484054926,0.033442240201468,0,0.966557759798532,0,226115.711159316
+0.496,0,632.402627997843,0.033406665069648,0,0.966593334930352,0,226045.496180115
+0.497,0,631.932730441,0.033371830656214,0,0.966628169343786,0,226003.140534421
+0.498,0,631.502366643596,0.033338257775093,0,0.966661742224907,0,225982.585630381
+0.499,0,631.115699245283,0.033306316823832,0,0.966693683176168,0,225981.373532
+0.5,0,630.776995781222,0.033276318377317,0,0.966723681622683,0,225998.449339646
+0.501,0,630.490303615619,0.033248539463335,0,0.966751460536665,0,226033.294059644
+0.502,0,630.25924654618,0.033223230455088,0,0.966776769544912,0,226085.559401463
+0.503,0,630.086894236231,0.033200615943792,0,0.966799384056209,0,226154.905161744
+0.504,0,629.9756688293,0.033180893629928,0,0.966819106370072,0,226240.919344911
+0.505,0,629.927273929913,0.033164232529544,0,0.966835767470456,0,226343.076584738
+0.506,0,629.942639332066,0.033150771009712,0,0.966849228990288,0,226460.715255707
+0.507,0,630.021876902189,0.033140614880472,0,0.966859385119528,0,226593.022018128
+0.508,0,630.164254819007,0.033133835753733,0,0.966866164246267,0,226739.027269743
+0.509,0,630.36817854087,0.033130469643684,0,0.966869530356316,0,226897.597801208
+0.51,0,630.63119737193,0.033130516107059,0,0.966869483892941,0,227067.442374103
+0.511,0,630.950021378676,0.033133937775374,0,0.966866062224626,0,227247.115658277
+0.512,0,631.320558996571,0.033140660464902,0,0.966859339535098,0,227435.029033269
+0.513,0,631.737971808434,0.033150573858308,0,0.966849426141692,0,227629.465065565
+0.514,0,632.196746691608,0.033163532785103,0,0.966836467214898,0,227828.596335862
+0.515,0,632.690783721221,0.033179359091581,0,0.966820640908419,0,228030.50830106
+0.516,0,633.212943994543,0.033197829411559,0,0.966802170588441,0,228232.970215256
+0.517,0,633.754221942049,0.033218626737887,0,0.966781373262113,0,228433.001431882
+0.518,0,634.304729501173,0.033241363308954,0,0.966758636691046,0,228627.395457969
+0.519,0,634.853884234124,0.033265590023553,0,0.966734409976447,0,228812.80075984
+0.52,0,635.390530929194,0.033290796416309,0,0.966709203583691,0,228985.738919871
+0.521,0,635.903091956704,0.03331641134916,0,0.966683588650841,0,229142.644325945
+0.522,0,636.379741115914,0.033341804627477,0,0.966658195372523,0,229279.921015954
+0.523,0,636.808996557584,0.033366339325722,0,0.966633660674278,0,229393.674120735
+0.524,0,637.18202768678,0.033389610928802,0,0.966610389071198,0,229478.450043729
+0.525,0,637.474710671406,0.033410228365022,0,0.966589771634978,0,229524.160359072
+0.526,0,637.650137645877,0.033425959631007,0,0.966574040368993,0,229515.677968078
+0.527,0,637.715928428338,0.033436552540243,0,0.966563447459757,0,229462.772798562
+0.528,0,637.680434945936,0.033441932651042,0,0.966558067348958,0,229373.316316327
+0.529,0,637.550581181114,0.033442041558306,0,0.966557958441694,0,229253.239991694
+0.53,0,637.331741874842,0.033436793431356,0,0.966563206568645,0,229107.181420396
+0.531,0,637.02825221798,0.033426108389365,0,0.966573891610636,0,228938.630302768
+0.532,0,636.645039185697,0.033409985041386,0,0.966590014958615,0,228751.034304164
+0.533,0,636.195485589896,0.033388794100679,0,0.966611205899322,0,228549.327644767
+0.534,0,635.675531569283,0.033362253567884,0,0.966637746432116,0,228331.822783859
+0.535,0,635.117174720787,0.033331989969643,0,0.966668010030358,0,228118.902035831
+0.536,0,634.566077126481,0.03330058651573,0,0.96669941348427,0,227932.654430579
+0.537,0,634.043772990659,0.033269588467114,0,0.966730411532886,0,227778.521300791
+0.538,0,633.556410055859,0.033239731633629,0,0.966760268366371,0,227653.41987056
+0.539,0,633.104350311514,0.033211362883251,0,0.966788637116749,0,227552.365946327
+0.54,0,632.686269953636,0.033184654879785,0,0.966815345120215,0,227470.772883169
+0.541,0,632.300472106542,0.033159695520567,0,0.966840304479433,0,227404.867925301
+0.542,0,631.945234269329,0.033136524892336,0,0.966863475107665,0,227351.597215404
+0.543,0,631.618874880156,0.033115152155583,0,0.966884847844417,0,227308.456853894
+0.544,0,631.319755297426,0.033095564016013,0,0.966904435983988,0,227273.365998805
+0.545,0,631.046267400128,0.033077729567162,0,0.966922270432838,0,227244.576305229
+0.546,0,630.79682088022,0.03306160324886,0,0.966938396751141,0,227220.609580611
+0.547,0,630.569831150912,0.033047126757687,0,0.966952873242313,0,227200.211676459
+0.548,0,630.363707985847,0.033034230367944,0,0.966965769632056,0,227182.315435227
+0.549,0,630.176848692022,0.033022834108348,0,0.966977165891652,0,227166.010788262
+0.55,0,630.008026993878,0.033012869005631,0,0.966987130994369,0,227150.740729586
+0.551,0,629.8566182371,0.033004293542328,0,0.966995706457672,0,227136.344180517
+0.552,0,629.721878125226,0.032997059098948,0,0.967002940901052,0,227122.602759652
+0.553,0,629.602968949045,0.032991108797935,0,0.967008891202065,0,227109.292511202
+0.554,0,629.499033683288,0.032986381073162,0,0.967013618926838,0,227096.223673955
+0.555,0,629.409452608113,0.032982840981583,0,0.967017159018417,0,227083.058389729
+0.556,0,629.334352394091,0.032980538192999,0,0.967019461807001,0,227069.030922414
+0.557,0,629.274285431561,0.03297955407801,0,0.96702044592199,0,227053.411044403
+0.558,0,629.230124984505,0.032979990873829,0,0.967020009126171,0,227035.541138056
+0.559,0,629.203035664196,0.032981969745752,0,0.967018030254248,0,227014.825945099
+0.56,0,629.194369598573,0.032985620374676,0,0.967014379625324,0,226990.770792618
+0.561,0,629.205603943622,0.032991077074605,0,0.967008922925395,0,226962.962638573
+0.562,0,629.238807534738,0.032998534571901,0,0.967001465428099,0,226930.720778267
+0.563,0,629.294121260584,0.033007945618397,0,0.966992054381604,0,226895.008194008
+0.564,0,629.369612869121,0.033019056726375,0,0.966980943273625,0,226857.632121095
+0.565,0,629.462411541697,0.033031554165386,0,0.966968445834614,0,226820.215062704
+0.566,0,629.569486484496,0.033045141691783,0,0.966954858308217,0,226783.870015787
+0.567,0,629.688082479464,0.033059573541988,0,0.966940426458012,0,226749.200223077
+0.568,0,629.81589081277,0.033074660223461,0,0.966925339776539,0,226716.424725652
+0.569,0,629.951060313794,0.033090261408192,0,0.966909738591808,0,226685.51786568
+0.57,0,630.092144939342,0.033106275734529,0,0.966893724265472,0,226656.318667524
+0.571,0,630.237856157695,0.033122602696984,0,0.966877397303016,0,226628.810468764
+0.572,0,630.386460952438,0.033139065175869,0,0.966860934824131,0,226603.511354217
+0.573,0,630.53698939877,0.033155606463703,0,0.966844393536297,0,226580.049522337
+0.574,0,630.688768373261,0.0331721935407,0,0.9668278064593,0,226558.069621498
+0.575,0,630.84125654813,0.03318879933869,0,0.96681120066131,0,226537.290804172
+0.576,0,630.994008406934,0.033205401232022,0,0.966794598767978,0,226517.484667208
+0.577,0,631.146658317461,0.033221980355199,0,0.966778019644801,0,226498.466553869
+0.578,0,631.298906241468,0.033238520961273,0,0.966761479038727,0,226480.087781917
+0.579,0,631.450505072379,0.033255009834809,0,0.966744990165191,0,226462.228774818
+0.58,0,631.601250116336,0.033271435794446,0,0.966728564205554,0,226444.793376699
+0.581,0,631.750970680376,0.033287789292306,0,0.966712210707694,0,226427.704280243
+0.582,0,631.899523337209,0.033304062092165,0,0.966695937907835,0,226410.899338982
+0.583,0,632.046786561182,0.033320247012298,0,0.966679752987702,0,226394.328618314
+0.584,0,632.192656666062,0.033336337734684,0,0.966663662265316,0,226377.952088231
+0.585,0,632.33704461012,0.033352328658022,0,0.966647671341978,0,226361.73775061
+0.586,0,632.479873065945,0.033368214756394,0,0.966631785243606,0,226345.660010639
+0.587,0,632.621074597094,0.033383991500789,0,0.966616008499211,0,226329.6985255
+0.588,0,632.760589991566,0.033399654783958,0,0.966600345216042,0,226313.837209141
+0.589,0,632.898366756345,0.033415200851456,0,0.966584799148544,0,226298.063360701
+0.59,0,633.034358014306,0.033430626256857,0,0.966569373743143,0,226282.36698084
+0.591,0,633.168521534169,0.033445927825691,0,0.966554072174309,0,226266.740224699
+0.592,0,633.300988550927,0.033461108384248,0,0.966538891615753,0,226251.263496975
+0.593,0,633.436053352877,0.033476318508447,0,0.966523681491554,0,226237.99309355
+0.594,0,632.998528463842,0.0334489353349,0,0.966551064665101,0,226134.373660983
+0.595,0,632.485647850014,0.033413307268741,0,0.966586692731259,0,226056.929868135
+0.596,0,632.008138633233,0.033378273208314,0,0.966621726791687,0,226009.494969629
+0.597,0,631.569383384527,0.033344411050914,0,0.966655588949087,0,225984.720315335
+0.598,0,631.173466584708,0.033312111425222,0,0.966687888574778,0,225979.647428431
+0.599,0,630.82466546213,0.033281694101481,0,0.966718305898519,0,225993.02563022
+0.6,0,630.527092535157,0.033253442181829,0,0.966746557818171,0,226024.26351287
+0.601,0,630.284471878188,0.033227611384835,0,0.966772388615165,0,226072.994576575
+0.602,0,630.099996044256,0.033204431689079,0,0.966795568310921,0,226138.884553407
+0.603,0,629.976226894838,0.033184106478892,0,0.966815893521108,0,226221.539857503
+0.604,0,629.915021053998,0.033166810839964,0,0.966833189160036,0,226320.460580263
+0.605,0,629.917470894792,0.033152689601812,0,0.966847310398188,0,226435.013801848
+0.606,0,629.983859236286,0.033141855411768,0,0.966858144588232,0,226564.418159027
+0.607,0,630.113627523067,0.033134387004578,0,0.966865612995422,0,226707.735130318
+0.608,0,630.305360346899,0.033130327814817,0,0.966869672185183,0,226863.86669479
+0.609,0,630.556778986324,0.033129684884978,0,0.966870315115022,0,227031.551876401
+0.61,0,630.864762820188,0.0331324284228,0,0.9668675715772,0,227209.376311571
+0.611,0,631.225379373005,0.033138491730821,0,0.966861508269179,0,227395.779175573
+0.612,0,631.633936609334,0.033147771785617,0,0.966852228214383,0,227589.067630356
+0.613,0,632.085051370255,0.033160130391041,0,0.966839869608959,0,227787.434593851
+0.614,0,632.57273438333,0.033175395928811,0,0.966824604071189,0,227988.980895405
+0.615,0,633.090185124071,0.033193358383166,0,0.966806641616834,0,228191.602726399
+0.616,0,633.628703681422,0.033213720312208,0,0.966786279687792,0,228392.436370837
+0.617,0,634.178549232182,0.033236106498708,0,0.966763893501292,0,228588.302711475
+0.618,0,634.729269889689,0.033260080379271,0,0.966739919620729,0,228775.87872318
+0.619,0,635.269813444117,0.03328514397814,0,0.966714856021861,0,228951.708728241
+0.62,0,635.788671501649,0.033310738427567,0,0.966689261572433,0,229112.239417584
+0.621,0,636.274049698367,0.0333362453668,0,0.9666637546332,0,229253.8744275
+0.622,0,636.714180414538,0.033361004777386,0,0.966638995222614,0,229372.937867332
+0.623,0,637.099976248916,0.033384606289034,0,0.966615393710966,0,229463.951635636
+0.624,0,637.414020098007,0.033406023389506,0,0.966593976610494,0,229519.86434138
+0.625,0,637.613456671968,0.033422808636554,0,0.966577191363447,0,229521.754515026
+0.626,0,637.701300481956,0.033434477036857,0,0.966565522963143,0,229477.219993355
+0.627,0,637.686242054381,0.03344094355149,0,0.96655905644851,0,229394.724819064
+0.628,0,637.575508489514,0.033442153113972,0,0.966557846886028,0,229280.491403297
+0.629,0,637.374761063787,0.033438022625608,0,0.966561977374392,0,229139.427501448
+0.63,0,637.088488410602,0.033428468823694,0,0.966571531176306,0,228975.208785676
+0.631,0,636.721233277133,0.033413460952234,0,0.966586539047766,0,228791.136280587
+0.632,0,636.284452839999,0.033393295483148,0,0.966606704516852,0,228592.179142987
+0.633,0,635.778856417401,0.033367847370236,0,0.966632152629764,0,228377.310990918
+0.634,0,635.223976101781,0.033338117010632,0,0.966661882989369,0,228161.010028048
+0.635,0,634.668917846276,0.033306789632494,0,0.966693210367506,0,227968.324186402
+0.636,0,634.139910083878,0.033275632912535,0,0.966724367087465,0,227807.653875515
+0.637,0,633.645278343925,0.033245508488408,0,0.966754491511592,0,227676.94918726
+0.638,0,633.186096101356,0.033216819761352,0,0.966783180238648,0,227571.323099481
+0.639,0,632.761223508976,0.033189765162522,0,0.966810234837478,0,227486.039307675
+0.64,0,632.368995230708,0.033164445911654,0,0.966835554088347,0,227417.159231201
+0.641,0,632.007683335081,0.033140910163968,0,0.966859089836032,0,227361.493787967
+0.642,0,631.675596708617,0.033119172533449,0,0.966880827466551,0,227316.438503121
+0.643,0,631.371088089944,0.033099223838002,0,0.966900776161998,0,227279.833740878
+0.644,0,631.092543488174,0.033081036478233,0,0.966918963521768,0,227249.868373212
+0.645,0,630.838369261833,0.033064567678845,0,0.966935432321155,0,227225.012900679
+0.646,0,630.606979743687,0.033049761594546,0,0.966950238405454,0,227203.970086331
+0.647,0,630.396786008478,0.033036550706956,0,0.966963449293044,0,227185.637158925
+0.648,0,630.20618503115,0.033024856885208,0,0.966975143114792,0,227169.07248979
+0.649,0,630.033795814131,0.033014604715262,0,0.966985395284739,0,227153.606794837
+0.65,0,629.878948377703,0.033005750510893,0,0.966994249489107,0,227139.051354349
+0.651,0,629.740929725451,0.032998247625423,0,0.967001752374577,0,227125.20110913
+0.652,0,629.618913924914,0.032992040594274,0,0.967007959405726,0,227111.827916961
+0.653,0,629.512041736354,0.032987068357723,0,0.967012931642277,0,227098.734549648
+0.654,0,629.419590454407,0.032983283568016,0,0.967016716431984,0,227085.656879423
+0.655,0,629.341548176067,0.032980721887233,0,0.967019278112767,0,227071.879234517
+0.656,0,629.278397785866,0.032979460403703,0,0.967020539596297,0,227056.651277153
+0.657,0,629.230950110925,0.032979597223522,0,0.967020402776478,0,227039.302806052
+0.658,0,629.200313732433,0.032981250001242,0,0.967018749998758,0,227019.224816499
+0.659,0,629.187814319467,0.032984547938044,0,0.967015452061956,0,226995.896352572
+0.66,0,629.194865859586,0.032989619216649,0,0.967010380783351,0,226968.927973922
+0.661,0,629.223511124559,0.032996659407574,0,0.967003340592426,0,226937.590569331
+0.662,0,629.27445646789,0.033005687004641,0,0.966994312995359,0,226902.454813128
+0.663,0,629.346086955862,0.033016475409644,0,0.966983524590356,0,226865.278582488
+0.664,0,629.435651420976,0.033028715354579,0,0.966971284645421,0,226827.763297856
+0.665,0,629.540105345133,0.03304210302333,0,0.96695789697667,0,226791.134548227
+0.666,0,629.656616956737,0.033056381227027,0,0.966943618772973,0,226756.09239031
+0.667,0,629.782778321035,0.033071348976556,0,0.966928651023444,0,226722.923661177
+0.668,0,629.916648161825,0.03308685672201,0,0.96691314327799,0,226691.642778926
+0.669,0,630.056703147862,0.033102795945079,0,0.966897204054922,0,226662.109633253
+0.67,0,630.201691269906,0.033119076856698,0,0.966880923143302,0,226634.200395096
+0.671,0,630.349879636234,0.033135520495405,0,0.966864479504595,0,226608.475096425
+0.672,0,630.500153229537,0.033152050801168,0,0.966847949198832,0,226584.672918483
+0.673,0,630.651802859158,0.033168633148694,0,0.966831366851307,0,226562.417507769
+0.674,0,630.804264901397,0.033185239436128,0,0.966814760563872,0,226541.415996239
+0.675,0,630.957075439876,0.033201846172364,0,0.966798153827636,0,226521.430045538
+0.676,0,631.109853591768,0.033218433767268,0,0.966781566232732,0,226502.26672473
+0.677,0,631.262286979843,0.03323498588424,0,0.966765014115761,0,226483.770625469
+0.678,0,631.414118395344,0.033251488822103,0,0.966748511177897,0,226465.816656227
+0.679,0,631.56513515136,0.033267931014958,0,0.966732068985042,0,226448.304273151
+0.68,0,631.715160167501,0.03328430260769,0,0.96671569739231,0,226431.15264329
+0.681,0,631.864044761326,0.033300595109528,0,0.966699404890472,0,226414.296733356
+0.682,0,632.011663274514,0.033316801139025,0,0.966683198860975,0,226397.684326952
+0.683,0,632.157908687969,0.033332914216985,0,0.966667085783015,0,226381.273551499
+0.684,0,632.302689027917,0.033348928595628,0,0.966651071404372,0,226365.030854618
+0.685,0,632.445924770927,0.033364839140905,0,0.966635160859095,0,226348.929454224
+0.686,0,632.587546609807,0.03338064122898,0,0.96661935877102,0,226332.948035515
+0.687,0,632.727493731764,0.033396330668819,0,0.966603669331181,0,226317.069716547
+0.688,0,632.865712358794,0.033411903637953,0,0.966588096362047,0,226301.281160004
+0.689,0,633.002154569103,0.033427356631175,0,0.966572643368826,0,226285.571884638
+0.69,0,633.136777229561,0.033442686418753,0,0.966557313581248,0,226269.933646914
+0.691,0.001860205933173,1350.77603512251,0.07766321090264,0,0.92233678909736,1.28152277082794,569685.028289367
+0.692,0.040138143749906,1348.62486439872,0.07766321090264,0,0.92233678909736,1.28162977963058,566536.009432004
+0.693,0.127220460301386,1346.45321400349,0.07766321090264,0,0.92233678909736,1.28173808035759,563359.019213127
+0.694,0.262136313075224,1344.22475096166,0.07766321090264,0,0.92233678909736,1.28184950063591,560084.83946499
+0.695,0.443700172486278,1341.90403575988,0.07766321090264,0,0.92233678909736,1.28196584267537,556647.250896266
+0.696,0.670466192224872,1339.45661619079,0.07766321090264,0,0.92233678909736,1.28208887965617,552983.303855514
+0.697,0.9406874359795,1336.8491309077,0.07766321090264,0,0.92233678909736,1.28222035221615,549033.662147642
+0.698,1.25228106179283,1334.04942140193,0.07766321090264,0,0.92233678909736,1.28236196502278,544742.997407802
+0.699,1.60280062713361,1331.0266519679,0.07766321090264,0,0.92233678909736,1.28251538336228,540060.430538978
+0.7,1.98941665984052,1327.75143610676,0.07766321090264,0,0.92233678909736,1.28268222972495,534939.999428948
+0.701,2.40890657743408,1324.19596795749,0.07766321090264,0,0.92233678909736,1.28286408034983,529341.137641617
+0.702,2.85765491742288,1320.33415732552,0.07766321090264,0,0.92233678909736,1.28306246168417,523229.148619146
+0.703,3.33166462725053,1316.14176611042,0.07766321090264,0,0.92233678909736,1.28327884674529,516575.653878244
+0.704,3.82657992226093,1311.59654439117,0.07766321090264,0,0.92233678909736,1.28351465134317,509358.999358524
+0.705,4.33772085550398,1306.67836331486,0.07766321090264,0,0.92233678909736,1.28377123017594,501564.596619489
+0.706,4.86012946287084,1301.36934366668,0.07766321090264,0,0.92233678909736,1.28404987271877,493185.190569271
+0.707,5.38862676083473,1295.6539756028,0.07766321090264,0,0.92233678909736,1.2843517990055,484221.022781122
+0.708,5.91787986535594,1289.51923187588,0.07766321090264,0,0.92233678909736,1.28467815504624,474679.908427181
+0.709,6.44247708792663,1282.95466181606,0.07766321090264,0,0.92233678909736,1.28503000842884,464577.149983327
+0.71,6.95701016061702,1275.95247880066,0.07766321090264,0,0.92233678909736,1.28540834331496,453935.376515015
+0.711,7.45616036345688,1268.50762409423,0.07766321090264,0,0.92233678909736,1.28581405564026,442784.212224158
+0.712,7.93478672549838,1260.6178146207,0.07766321090264,0,0.92233678909736,1.28624794803683,431159.835314036
+0.713,8.38801346631785,1252.28357034879,0.07766321090264,0,0.92233678909736,1.28671072464728,419104.414869395
+0.714,8.80899831125467,1243.31696856896,0.07766321090264,0,0.92233678909736,1.28691542948956,406706.644462537
+0.715,9.18235594180479,1233.8109980799,0.07766321090264,0,0.92233678909736,1.28694377888755,394011.106126263
+0.716,9.49822243827181,1223.91789729117,0.07766321090264,0,0.92233678909736,1.2869722704512,381067.206976067
+0.717,9.74734440396964,1213.67592482534,0.07766321090264,0,0.92233678909736,1.28700094987515,367959.801623863
+0.718,9.92036463998498,1203.13354818666,0.07766321090264,0,0.92233678909736,1.28702986609672,354782.361870388
+0.719,10.0079426959368,1192.35062264653,0.07766321090264,0,0.92233678909736,1.28705907498891,341636.363430705
+0.72,10.0008982943615,1181.39958759484,0.07766321090264,0,0.92233678909736,1.28708864383915,328630.50646309
+0.721,9.89037775332795,1170.36662248985,0.07766321090264,0,0.92233678909736,1.28711865514553,315879.762204868
+0.722,9.6681103959141,1159.35268490134,0.07766321090264,0,0.92233678909736,1.28714932243489,303504.268458773
+0.723,9.2102542657988,1148.4920399844,0.07766321090264,0,0.92233678909736,1.28718089021211,291648.127832992
+0.724,8.42754395260692,1138.17279793134,0.07766321090264,0,0.92233678909736,1.28721450029272,280716.176414282
+0.725,7.62872069455795,1128.54846304686,0.07766321090264,0,0.92233678909736,1.28725000538248,270819.007535066
+0.726,6.81404494036308,1119.66862633572,0.07766321090264,0,0.92233678909736,1.28728698915601,261947.177765388
+0.727,5.98358044069186,1111.58247552644,0.07766321090264,0,0.92233678909736,1.28732520465176,254092.019816591
+0.728,5.13695448114833,1104.33830148641,0.07766321090264,0,0.92233678909736,1.28736449677566,247246.237115528
+0.729,4.27312176120596,1097.98442303087,0.07766321090264,0,0.92233678909736,1.28740478300861,241405.893669079
+0.73,3.40452217446341,1092.64130436653,0.07766321090264,0,0.92233678909736,1.28744601285075,236641.311646289
+0.731,2.56824203625081,1088.46109259746,0.07766321090264,0,0.92233678909736,1.28748802914516,233055.311294238
+0.732,1.65337337162289,1085.06479068021,0.07766321090264,0,0.92233678909736,1.28753072937875,230247.98158299
+0.733,1.06906036504815,1083.26217949216,0.07766321090264,0,0.92233678909736,1.28757373207282,228966.599146163
+0.734,0.876663199202646,1082.33689442341,0.07766321090264,0,0.92233678909736,1.28761546762302,228518.211105484
+0.735,0.894666724191961,1081.73188348802,0.07766321090264,0,0.92233678909736,1.28765509880222,228372.23413726
+0.736,1.00436237143073,1081.2851239727,0.07766321090264,0,0.92233678909736,1.28769262711467,228374.733931093
+0.737,1.1523970418893,1080.94565748139,0.07766321090264,0,0.92233678909736,1.28772834794743,228477.469821026
+0.738,1.3158977384302,1080.68937777291,0.07766321090264,0,0.92233678909736,1.28776258663896,228657.866984833
+0.739,1.48420609826403,1080.49992465031,0.07766321090264,0,0.92233678909736,1.2877956284667,228900.822147417
+0.74,1.65164593418034,1080.36354381418,0.07766321090264,0,0.92233678909736,1.28782771296722,229193.765996127
+0.741,1.81479408435133,1080.26754287127,0.07766321090264,0,0.92233678909736,1.28785904142218,229525.139643444
+0.742,1.97139096104003,1080.19989017675,0.07766321090264,0,0.92233678909736,1.28788978370069,229883.958876295
+0.743,2.11984906397731,1080.14917617339,0.07766321090264,0,0.92233678909736,1.28792008244149,230259.728388388
+0.744,2.25899609100779,1080.10466088611,0.07766321090264,0,0.92233678909736,1.28795005526805,230642.445198848
+0.745,2.38792176346054,1080.05631615869,0.07766321090264,0,0.92233678909736,1.2879797958931,231022.604570233
+0.746,2.50587571512971,1079.99483535106,0.07766321090264,0,0.92233678909736,1.28800937468984,231391.181722336
+0.747,2.61219131731856,1079.91160173453,0.07766321090264,0,0.92233678909736,1.28803883905282,231739.579730436
+0.748,2.7098268745338,1079.81233383377,0.07766321090264,0,0.92233678909736,1.28806821309151,232072.79175602
+0.749,2.80389819854535,1079.71349071267,0.07766321090264,0,0.92233678909736,1.28809750468702,232406.453569203
+0.75,2.89323390338939,1079.60869844004,0.07766321090264,0,0.92233678909736,1.28812672704263,232734.433437945
+0.751,2.97723171310973,1079.49342646925,0.07766321090264,0,0.92233678909736,1.28815589631488,233052.343637172
+0.752,3.05570851757289,1079.36480716139,0.07766321090264,0,0.92233678909736,1.28818502690007,233357.378905968
+0.753,3.12875282190376,1079.22120564011,0.07766321090264,0,0.92233678909736,1.28821413396455,233647.912463482
+0.754,3.19671045059344,1079.06188444208,0.07766321090264,0,0.92233678909736,1.28824326095192,233923.181555919
+0.755,3.26004582220722,1078.88676005469,0.07766321090264,0,0.92233678909736,1.28827246064308,234183.055979154
+0.756,3.31926619505796,1078.69630234075,0.07766321090264,0,0.92233678909736,1.28830177983767,234427.943384881
+0.757,3.37488099100398,1078.49130056704,0.07766321090264,0,0.92233678909736,1.28833126119429,234658.565297055
+0.758,3.42739295845778,1078.27280991241,0.07766321090264,0,0.92233678909736,1.28836094206418,234875.906356409
+0.759,3.47721211866282,1078.04177004919,0.07766321090264,0,0.92233678909736,1.28839085015461,235080.844139104
+0.76,3.52465886748447,1077.79855376022,0.07766321090264,0,0.92233678909736,1.28842103177973,235273.710445254
+0.761,3.56961548531633,1077.54228316697,0.07766321090264,0,0.92233678909736,1.28845147755544,235453.61815758
+0.762,3.61172710356952,1077.27238290326,0.07766321090264,0,0.92233678909736,1.28848207547017,235619.968403498
+0.763,3.65080355180372,1076.98916699342,0.07766321090264,0,0.92233678909736,1.28851270562662,235773.030210245
+0.764,3.68683089522315,1076.69341329231,0.07766321090264,0,0.92233678909736,1.28854327722909,235913.530230723
+0.765,3.7199221417282,1076.38605595529,0.07766321090264,0,0.92233678909736,1.28857373575658,236042.35384128
+0.766,3.75026449032913,1076.0680333444,0.07766321090264,0,0.92233678909736,1.2886040566529,236160.396163105
+0.767,3.77807340868029,1075.7401971677,0.07766321090264,0,0.92233678909736,1.28863423585164,236268.472271811
+0.768,3.80356709414726,1075.4033003727,0.07766321090264,0,0.92233678909736,1.2886642812948,236367.304351995
+0.769,3.82694870570761,1075.0580029822,0.07766321090264,0,0.92233678909736,1.28869420559466,236457.526548244
+0.77,3.84828338407388,1074.70494451238,0.07766321090264,0,0.92233678909736,1.28872397490321,236539.753126958
+0.771,3.86773738561713,1074.34476227019,0.07766321090264,0,0.92233678909736,1.28875359478097,236614.600319572
+0.772,3.88546902241532,1073.97776792598,0.07766321090264,0,0.92233678909736,1.28878309275041,236682.367936429
+0.773,3.90146174363889,1073.60344859844,0.07766321090264,0,0.92233678909736,1.2888124900191,236742.547164304
+0.774,3.91576450180768,1073.22171636839,0.07766321090264,0,0.92233678909736,1.28884180386422,236795.046412455
+0.775,3.92850599350447,1072.83298014835,0.07766321090264,0,0.92233678909736,1.28887104833237,236840.263222756
+0.776,3.93984107507102,1072.43784847741,0.07766321090264,0,0.92233678909736,1.28890023483883,236878.793302152
+0.777,3.94992527999293,1072.03698119944,0.07766321090264,0,0.92233678909736,1.28892937269476,236911.285176176
+0.778,3.95890028799832,1071.6310006139,0.07766321090264,0,0.92233678909736,1.28895846954482,236938.353028757
+0.779,3.96689214048421,1071.22047289176,0.07766321090264,0,0.92233678909736,1.28898753175098,236960.55864219
+0.78,3.97400879556655,1070.80588759916,0.07766321090264,0,0.92233678909736,1.28901656469457,236978.391572545
+0.781,3.98034382504271,1070.38767180944,0.07766321090264,0,0.92233678909736,1.28904557304821,236992.283647173
+0.782,3.9859770388849,1069.96618816479,0.07766321090264,0,0.92233678909736,1.28907456103017,237002.608074097
+0.783,3.99097749748671,1069.54174632985,0.07766321090264,0,0.92233678909736,1.2891035326622,237009.692419786
+0.784,3.99540360178673,1069.11459795693,0.07766321090264,0,0.92233678909736,1.28913249207466,237013.816476106
+0.785,3.99930652092349,1068.68494825159,0.07766321090264,0,0.92233678909736,1.28916144393673,237015.22865425
+0.786,4.00273114764355,1068.25295016541,0.07766321090264,0,0.92233678909736,1.28919039414078,237014.149443727
+0.787,4.0057162588962,1067.81868522212,0.07766321090264,0,0.92233678909736,1.28921935107107,237010.7708482
+0.788,4.00829560739685,1067.38212607836,0.07766321090264,0,0.92233678909736,1.28924832838127,237005.260789155
+0.789,4.01049919216376,1066.94302984668,0.07766321090264,0,0.92233678909736,1.28927735228872,236997.767966992
+0.79,4.0123552430251,1066.50055087589,0.07766321090264,0,0.92233678909736,1.28930648714783,236988.428203719
+0.791,4.01374220791824,1066.05074888125,0.07766321090264,0,0.92233678909736,1.2893359376171,236977.404724767
+0.792,7.64060775491714,314.236474705576,0.010348329479448,0,0.989651670520552,1.39790015626665,237675.597659528
+0.793,7.91566392742354,314.539338884559,0.010348329479448,0,0.989651670520552,1.39790103348763,238444.582531466
+0.794,8.01980172452113,314.657279658658,0.010348329479448,0,0.989651670520552,1.39790139519502,238722.878403686
+0.795,8.06996243741103,314.719722781433,0.010348329479448,0,0.989651670520552,1.39790139422909,238853.770370536
+0.796,8.10114095053889,314.766621554551,0.010348329479448,0,0.989651670520552,1.39790109180272,238943.489843395
+0.797,8.12317478447289,314.809133878483,0.010348329479448,0,0.989651670520552,1.39790051332143,239021.724579658
+0.798,8.1388664771153,314.850326181588,0.010348329479448,0,0.989651670520552,1.39789967010821,239096.633182998
+0.799,8.1490870349796,314.891069388214,0.010348329479448,0,0.989651670520552,1.39789856823537,239170.530778815
+0.8,8.15418073118848,314.931642675175,0.010348329479448,0,0.989651670520552,1.39789721239506,239244.157284154
+0.801,8.15435257870016,314.972159818237,0.010348329479448,0,0.989651670520552,1.39789560770735,239317.812186632
+0.802,8.14978357213288,315.012686782029,0.010348329479448,0,0.989651670520552,1.39789376062815,239391.667498313
+0.803,8.14066606549246,315.05327179075,0.010348329479448,0,0.989651670520552,1.39789167943804,239465.847738866
+0.804,8.12721699732321,315.093953043766,0.010348329479448,0,0.989651670520552,1.39788937452192,239540.450427299
+0.805,8.10968492629492,315.13476078634,0.010348329479448,0,0.989651670520552,1.39788685855381,239615.551560841
+0.806,8.08835499087546,315.175718120984,0.010348329479448,0,0.989651670520552,1.39788414661297,239691.207758542
+0.807,8.06354677313454,315.216838382064,0.010348329479448,0,0.989651670520552,1.39788125607082,239767.449306322
+0.808,8.03562314870132,315.258127912944,0.010348329479448,0,0.989651670520552,1.39787820679708,239844.287512565
+0.809,8.00498527389901,315.299584890401,0.010348329479448,0,0.989651670520552,1.39787502082348,239921.711694598
+0.81,7.97207508126387,315.341200541795,0.010348329479448,0,0.989651670520552,1.39787172228448,239999.692461139
+0.811,7.93736844869214,315.382954145666,0.010348329479448,0,0.989651670520552,1.39786833715585,240078.168456647
+0.812,7.90137509891448,315.424817081875,0.010348329479448,0,0.989651670520552,1.39786489296673,240157.057280924
+0.813,7.86463694490036,315.466749378628,0.010348329479448,0,0.989651670520552,1.39786141876017,240236.24632882
+0.814,7.82787325521107,315.508697010338,0.010348329479448,0,0.989651670520552,1.39785795214153,240315.584120873
+0.815,7.79197341863055,315.550577741998,0.010348329479448,0,0.989651670520552,1.39785453925735,240394.842612109
+0.816,7.75787674328232,315.592286341312,0.010348329479448,0,0.989651670520552,1.39785122863572,240473.732619313
+0.817,7.7265721529412,315.633700231447,0.010348329479448,0,0.989651670520552,1.39784807097465,240551.919193489
+0.818,7.69908349800383,315.674674908732,0.010348329479448,0,0.989651670520552,1.39784511875292,240629.009777141
+0.819,7.67645015661298,315.715043838172,0.010348329479448,0,0.989651670520552,1.39784242553979,240704.554559326
+0.82,7.65970069357743,315.754618741179,0.010348329479448,0,0.989651670520552,1.39784004507015,240778.048197086
+0.821,7.65016342037141,315.793181811822,0.010348329479448,0,0.989651670520552,1.39783804658934,240848.906912648
+0.822,7.64915541192506,315.830457990239,0.010348329479448,0,0.989651670520552,1.3978365018681,240916.399191815
+0.823,7.66204250962106,315.866018399899,0.010348329479448,0,0.989651670520552,1.39783568113587,240979.349166178
+0.824,7.68895905396757,315.899254490212,0.010348329479448,0,0.989651670520552,1.39783562011956,241036.167646522
+0.825,7.7265095651889,315.929952334951,0.010348329479448,0,0.989651670520552,1.39783617473609,241086.387198006
+0.826,7.77230655751417,315.958027767527,0.010348329479448,0,0.989651670520552,1.39783724315361,241129.930103551
+0.827,7.82448296428797,315.983364340743,0.010348329479448,0,0.989651670520552,1.39783874849906,241166.737739641
+0.828,7.88156121610461,316.00571163492,0.010348329479448,0,0.989651670520552,1.39784063623989,241196.677911281
+0.829,7.94221003607652,316.024202944202,0.010348329479448,0,0.989651670520552,1.39784288108441,241219.057563638
+0.83,8.00416166630552,316.031179783372,0.010348329479448,0,0.989651670520552,1.39784566657832,241230.508386569
+0.831,7.98468722717061,322.000678621819,0.010413180319254,0,0.989586819680746,1.39758678421394,241210.216632881
+0.832,8.04014246682482,321.927892833124,0.010408632433934,0,0.989591367566066,1.39759478473649,241178.737564574
+0.833,8.08562105564555,321.84957922687,0.010404133662388,0,0.989595866337612,1.39760247514161,241130.251399203
+0.834,8.11652734253565,321.765435627262,0.010399693991535,0,0.989600306008465,1.39760959804545,241063.593912617
+0.835,8.13283748183371,321.675688806629,0.010395321594111,0,0.989604678405889,1.39761612925357,240979.014597523
+0.836,8.13598077728863,321.58056512907,0.010391023843753,0,0.989608976156247,1.39762213136865,240876.776160887
+0.837,8.12741327607212,321.480187693222,0.010386807473312,0,0.989613192526688,1.39762767774011,240756.892918986
+0.838,8.10827946683845,321.374597771424,0.010382678611777,0,0.989617321388223,1.39763283112609,240619.189199249
+0.839,8.07940040256396,321.263765925947,0.010378642967945,0,0.989621357032056,1.3976376415292,240463.321636934
+0.84,8.04132688437703,321.147595353634,0.010374706037984,0,0.989625293962017,1.39764214846606,240288.779596693
+0.841,7.99437998142872,321.025915341541,0.010370873326009,0,0.989629126673991,1.39764638326552,240094.859581719
+0.842,7.93866840252509,320.898465895331,0.010367150582718,0,0.989632849417282,1.39765037068457,239880.616656126
+0.843,7.87408562210655,320.764875087402,0.010363544071055,0,0.989636455928945,1.39765412992057,239644.796952797
+0.844,7.80029332470569,320.624632661438,0.010360060849319,0,0.989639939150681,1.39765767525778,239385.761248805
+0.845,7.71669095438911,320.477057752685,0.010356709091089,0,0.989643290908911,1.39766101648425,239101.393966914
+0.846,7.62237111759328,320.321260470461,0.010353498452389,0,0.989646501547611,1.39766415917354,238788.997502819
+0.847,7.51604871321288,320.156097128437,0.010350440496141,0,0.989649559503859,1.39766710437196,238445.172346975
+0.848,7.39587887971701,319.980126699841,0.010347549179032,0,0.989652450820969,1.39766984343757,238065.705132274
+0.849,7.25951155492728,319.791643258091,0.010344841018926,0,0.989655158981074,1.39767236291759,237645.666925462
+0.85,7.10484205892186,319.589482561694,0.010342331106556,0,0.989657668893444,1.39767465152052,237181.619751425
+0.851,6.92964288978488,319.372700325188,0.010340034737861,0,0.989659965262139,1.39767669749986,236670.733204225
+0.852,6.73091023021189,319.13999574758,0.010337970722648,0,0.989662029277353,1.39767848621168,236109.224486709
+0.853,6.50484750374705,318.88976493528,0.010336161616136,0,0.989663838383864,1.39768000590942,235492.525521907
+0.854,6.24663054730128,318.6201656919,0.010334633968216,0,0.989665366031784,1.39768124668014,234815.488997479
+0.855,5.95054471572699,318.329730680086,0.010333415927481,0,0.989666584072519,1.39768219786061,234074.109128633
+0.856,5.61161879223176,318.019145836213,0.010332528212169,0,0.989667471787831,1.39768285746512,233270.431085921
+0.857,5.22747105017253,317.692791521129,0.010331975663843,0,0.989668024336157,1.39768323974226,232416.696141239
+0.858,4.80163324873947,317.360603999386,0.010331733784033,0,0.989668266215967,1.39768338504696,231540.278844077
+0.859,4.30428713217802,317.009304574057,0.010331704662459,0,0.989668295337541,1.39768339625146,230610.70508784
+0.86,3.80930594008686,316.696688447979,0.010331704662459,0,0.989668295337541,1.39768343540978,229780.744134349
+0.861,3.38694334277293,316.45901948227,0.010331704662459,0,0.989668295337541,1.39768350680849,229142.871038905
+0.862,3.05872207094641,316.292827420666,0.010331704662459,0,0.989668295337541,1.39768358666896,228687.422476339
+0.863,2.82052248192884,316.182423339759,0.010331704662459,0,0.989668295337541,1.39768365563924,228374.00094088
+0.864,2.65700735763254,316.111798441251,0.010331704662459,0,0.989668295337541,1.39768370124727,228161.686331006
+0.865,2.55083317982681,316.06852736786,0.010331704662459,0,0.989668295337541,1.39768371747618,228018.820164684
+0.866,2.48659813455114,316.043844087913,0.010331704662459,0,0.989668295337541,1.39768370296766,227923.108709321
+0.867,2.45228008485899,316.031864597267,0.010331704662459,0,0.989668295337541,1.39768365930329,227859.604876656
+0.868,2.43898760005374,316.028658285683,0.010331704662459,0,0.989668295337541,1.3976835895951,227818.331522462
+0.869,2.43983092872501,316.031600452611,0.010331704662459,0,0.989668295337541,1.39768348889239,227792.631420933
+0.87,2.45020631971419,316.039010535939,0.010331704662459,0,0.989668295337541,1.39768335437967,227778.24389835
+0.871,2.46750121492503,316.049763571197,0.010331704662459,0,0.989668295337541,1.39768319286762,227772.316665108
+0.872,2.48982006299418,316.063054404677,0.010331704662459,0,0.989668295337541,1.3976830094821,227772.80909313
+0.873,2.51582331396358,316.078308947976,0.010331704662459,0,0.989668295337541,1.39768280835066,227778.266710225
+0.874,2.54455793303419,316.09511155494,0.010331704662459,0,0.989668295337541,1.39768259283062,227787.636884615
+0.875,2.57534272428828,316.113158801481,0.010331704662459,0,0.989668295337541,1.39768236563468,227800.151560258
+0.876,2.60768736528983,316.132227123215,0.010331704662459,0,0.989668295337541,1.39768212894983,227815.245175396
+0.877,2.64123621178474,316.152150352102,0.010331704662459,0,0.989668295337541,1.39768188453857,227832.497701305
+0.878,2.6757291175589,316.17280393879,0.010331704662459,0,0.989668295337541,1.39768163382213,227851.5946419
+0.879,2.710974017132,316.194093770572,0.010331704662459,0,0.989668295337541,1.39768137794743,227872.298688922
+0.88,2.74682766470413,316.215948178961,0.010331704662459,0,0.989668295337541,1.39768111784049,227894.429464966
+0.881,2.78318204848172,316.238312180015,0.010331704662459,0,0.989668295337541,1.39768085424917,227917.848926959
+0.882,2.81995476558356,316.261143289008,0.010331704662459,0,0.989668295337541,1.39768058777732,227942.450760247
+0.883,2.85708216753612,316.284408452537,0.010331704662459,0,0.989668295337541,1.39768031891238,227968.15260469
+0.884,2.89451444872395,316.308081778959,0.010331704662459,0,0.989668295337541,1.39768004804774,227994.890303743
+0.885,2.93221210159879,316.332142843076,0.010331704662459,0,0.989668295337541,1.39767977550092,228022.613608515
+0.886,2.97014333756479,316.356575407039,0.010331704662459,0,0.989668295337541,1.39767950152845,228051.282936238
+0.887,3.00828219455133,316.381366445362,0.010331704662459,0,0.989668295337541,1.39767922633808,228080.866899025
+0.888,3.04660713862548,316.40650539408,0.010331704662459,0,0.989668295337541,1.39767895009887,228111.340400251
+0.889,3.08510003334808,316.431983566643,0.010331704662459,0,0.989668295337541,1.39767867294985,228142.683153036
+0.89,3.12328607604647,316.457760339539,0.010331704662459,0,0.989668295337541,1.39767838722095,228174.795188882
+0.891,3.1870192041976,316.486386945005,0.010331704662459,0,0.989668295337541,1.39767851218156,228214.07703732
+0.892,3.29061836943612,316.51126093806,0.010331704662459,0,0.989668295337541,1.39767964981311,228243.743157397
+0.893,3.34167542611824,316.525586985898,0.010331704662459,0,0.989668295337541,1.39768015768096,228246.818870718
+0.894,3.36771605115924,316.537403711401,0.010331704662459,0,0.989668295337541,1.39768024462299,228243.614169965
+0.895,3.38069974986454,316.550698012638,0.010331704662459,0,0.989668295337541,1.39767999290235,228244.204659596
+0.896,3.38639108990742,316.567617710165,0.010331704662459,0,0.989668295337541,1.39767943608856,228254.020184263
+0.897,3.38785768575143,316.589410295705,0.010331704662459,0,0.989668295337541,1.39767858874431,228276.217045176
+0.898,3.38690122592513,316.616843386748,0.010331704662459,0,0.989668295337541,1.39767745827598,228312.740873763
+0.899,3.38469268603616,316.650404391362,0.010331704662459,0,0.989668295337541,1.39767604998183,228364.831504541
+0.9,3.3820720974099,316.690399859639,0.010331704662459,0,0.989668295337541,1.39767436932298,228433.274219901
+0.901,3.37970068151923,316.737007343396,0.010331704662459,0,0.989668295337541,1.3976724230583,228518.530840948
+0.902,3.37814061871429,316.79030302408,0.010331704662459,0,0.989668295337541,1.39767021984641,228620.80944827
+0.903,3.37789705988998,316.85027645674,0.010331704662459,0,0.989668295337541,1.39766777057878,228740.101410649
+0.904,3.37944167524979,316.916838546636,0.010331704662459,0,0.989668295337541,1.39766508860545,228876.201183915
+0.905,3.38322183675265,316.989825858641,0.010331704662459,0,0.989668295337541,1.39766218981389,229028.716712878
+0.906,3.38966477174095,317.069003060907,0.010331704662459,0,0.989668295337541,1.39765909268823,229197.075006955
+0.907,3.39917725289552,317.154064824424,0.010331704662459,0,0.989668295337541,1.39765581830547,229380.526241634
+0.908,3.41213803120163,317.244637902419,0.010331704662459,0,0.989668295337541,1.39765239017477,229578.148225251
+0.909,3.4288923238099,317.340283773311,0.010331704662459,0,0.989668295337541,1.39764883410064,229788.85225021
+0.91,3.44974313104334,317.440502110508,0.010331704662459,0,0.989668295337541,1.39764517793909,230011.391013069
+0.911,3.4749431335585,317.544736021114,0.010331704662459,0,0.989668295337541,1.39764145128157,230244.371031625
+0.912,3.50468845559117,317.652377532937,0.010331704662459,0,0.989668295337541,1.39763768515013,230486.265745355
+0.913,3.53941724483784,317.762797945844,0.010331704662459,0,0.989668295337541,1.39763391753876,230735.491285016
+0.914,3.57987933131877,317.875296298831,0.010331704662459,0,0.989668295337541,1.3976301975297,230990.274154426
+0.915,3.62663595598443,317.989030162957,0.010331704662459,0,0.989668295337541,1.39762657720592,231248.474781315
+0.916,3.68007933386414,318.103042289403,0.010331704662459,0,0.989668295337541,1.39762311103492,231507.654065643
+0.917,3.74045431889113,318.216280882265,0.010331704662459,0,0.989668295337541,1.39761985550654,231765.124022913
+0.918,3.80785927672954,318.327614349713,0.010331704662459,0,0.989668295337541,1.39761686844026,232017.984728472
+0.919,3.88223642763314,318.435843831663,0.010331704662459,0,0.989668295337541,1.39761420802076,232263.155932766
+0.92,3.87296745552693,318.545699684456,0.010331704662459,0,0.989668295337541,1.39761194175714,232512.764249625
+0.921,3.83688009032927,318.676046385104,0.010331704662459,0,0.989668295337541,1.39761015473698,232815.313930841
+0.922,3.82698087007591,318.822733642085,0.010331704662459,0,0.989668295337541,1.3976090677769,233160.324849721
+0.923,3.82848527697692,318.978295403586,0.010331704662459,0,0.989668295337541,1.39760884092762,233528.740139646
+0.924,3.82020582039777,319.134698124118,0.010331704662459,0,0.989668295337541,1.39760930786434,233899.934380853
+0.925,3.7919256916382,319.287179782823,0.010331704662459,0,0.989668295337541,1.39761034670227,234261.503293718
+0.926,3.7550084568063,319.450273821518,0.010331704662459,0,0.989668295337541,1.39761186461844,234650.827168965
+0.927,3.7089100428102,319.62848162166,0.010331704662459,0,0.989668295337541,1.3976137905073,235079.646290833
+0.928,3.65141214882383,319.823784470862,0.010331704662459,0,0.989668295337541,1.39761607065966,235553.251144146
+0.929,3.58105606390987,320.038507854582,0.010331704662459,0,0.989668295337541,1.39761864645061,236077.871458206
+0.93,3.49688911646298,320.275250266,0.010331704662459,0,0.989668295337541,1.39762144713539,236660.508141864
+0.931,3.39937884197018,320.53666085473,0.010331704662459,0,0.989668295337541,1.39762448334667,237308.354352841
+0.932,3.28519584080385,320.825682630839,0.010331704662459,0,0.989668295337541,1.39762736747193,238029.535146759
+0.933,3.15390632041595,321.145730267739,0.010331704662459,0,0.989668295337541,1.39762979220185,238833.50872183
+0.934,3.00801705538094,321.500075370706,0.010331704662459,0,0.989668295337541,1.39763170581813,239729.454445146
+0.935,2.85045451145327,321.891557076835,0.010331704662459,0,0.989668295337541,1.39763316870359,240725.555402538
+0.936,2.68370856809621,322.322585640681,0.010331704662459,0,0.989668295337541,1.39763426139313,241829.031191882
+0.937,2.50985204606626,322.795209391707,0.010331704662459,0,0.989668295337541,1.39763505554709,243046.323834549
+0.938,2.33074224390663,323.311160206309,0.010331704662459,0,0.989668295337541,1.39763560972526,244383.222072235
+0.939,2.14819520772903,323.871866352417,0.010331704662459,0,0.989668295337541,1.3976359714392,245844.896788398
+0.94,1.96410420176476,324.478439943027,0.010331704662459,0,0.989668295337541,1.39763617974745,247435.865730148
+0.941,1.78051377944175,325.131647350778,0.010331704662459,0,0.989668295337541,1.39763626721405,249159.907831517
+0.942,1.59966272843511,325.831868917191,0.010331704662459,0,0.989668295337541,1.39763626125417,251019.94203445
+0.943,1.42400488009143,326.579052520292,0.010331704662459,0,0.989668295337541,1.39763618507832,253017.880972746
+0.944,1.25621328036016,327.372664420332,0.010331704662459,0,0.989668295337541,1.39763605840246,255154.467097753
+0.945,1.09917113249469,328.211640092933,0.010331704662459,0,0.989668295337541,1.39763589802793,257429.097265371
+0.946,0.955951652817956,329.094337274039,0.010331704662459,0,0.989668295337541,1.3976357181898,259839.640987061
+0.947,0.829786045542914,330.018492887208,0.010331704662459,0,0.989668295337541,1.39763552638648,262382.257860123
+0.948,0.724029769391163,330.981186351732,0.010331704662459,0,0.989668295337541,1.39763532529234,265051.218234868
+0.949,0.642120438245946,331.978809506569,0.010331704662459,0,0.989668295337541,1.39763511870119,267838.728914069
+0.95,0.587524445645762,333.007044300113,0.010331704662459,0,0.989668295337541,1.39763491035436,270734.772166982
+0.951,0.562241185582167,334.060875624352,0.010331704662459,0,0.989668295337541,1.39763470352598,273727.036872829
+0.952,0.543577103970854,335.136909351006,0.010331704662459,0,0.989668295337541,1.39763450507388,276807.521723505
+0.953,0.522690363767732,336.235537281271,0.010331704662459,0,0.989668295337541,1.39763432740635,279979.014569969
+0.954,0.499630332385868,337.357559752104,0.010331704662459,0,0.989668295337541,1.39763418177907,283245.590709584
+0.955,0.474437354888811,338.503783803088,0.010331704662459,0,0.989668295337541,1.39763407825465,286611.466025867
+0.956,0.447144237579943,339.675025958141,0.010331704662459,0,0.989668295337541,1.39763402593088,290081.026685928
+0.957,0.417777217294303,340.872112893297,0.010331704662459,0,0.989668295337541,1.39763403197711,293658.82446396
+0.958,0.386357219171873,342.095883647756,0.010331704662459,0,0.989668295337541,1.39763410350349,297349.597015658
+0.959,0.352900650165678,343.347191143397,0.010331704662459,0,0.989668295337541,1.39763424874574,301158.280276237
+0.96,0.317417544354561,344.626898451097,0.010331704662459,0,0.989668295337541,1.39763444724614,305090.020882491
+0.961,0.279915431526533,345.935882834541,0.010331704662459,0,0.989668295337541,1.39763466922691,309150.191285979
+0.962,0.240400684658453,347.275038771349,0.010331704662459,0,0.989668295337541,1.39763488930676,313344.401903311
+0.963,0.198878301054602,348.645279643475,0.010331704662459,0,0.989668295337541,1.39763509051948,317678.515189193
+0.964,0.155351378540489,350.04753874002,0.010331704662459,0,0.989668295337541,1.39763526377498,322158.660024269
+0.965,0.109820740944928,351.48277011889,0.010331704662459,0,0.989668295337541,1.39763540570576,326791.248629046
+0.966,0.062284793287238,352.951949340425,0.010331704662459,0,0.989668295337541,1.39763551647164,331582.992665512
+0.967,0.01273955132835,354.456074516311,0.010331704662459,0,0.989668295337541,1.39763559812115,336540.924173145
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/reactionsGRI b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/reactionsGRI
new file mode 100644
index 0000000000000000000000000000000000000000..6c75e4743726d85f188975244e71ebfae3158b30
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/reactionsGRI
@@ -0,0 +1,10 @@
+species
+(
+O2
+N2
+)
+;
+
+reactions
+{}
+
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/thermo.compressibleGasGRI b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/thermo.compressibleGasGRI
new file mode 100644
index 0000000000000000000000000000000000000000..00ac37428a1011aa2ba2c7fde52c18b609f86b7f
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/thermo.compressibleGasGRI
@@ -0,0 +1,49 @@
+N2
+{
+    specie
+    {
+        molWeight       28.0134;
+    }
+    thermodynamics
+    {
+        Tlow            250;
+        Thigh           5000;
+        Tcommon         1000;
+        highCpCoeffs    ( 2.92664 0.0014879768 -5.68476e-07 1.0097038e-10 -6.753351e-15 -922.7977 5.980528 );
+        lowCpCoeffs     ( 3.298677 0.0014082404 -3.963222e-06 5.641515e-09 -2.444854e-12 -1020.8999 3.950372 );
+    }
+    transport
+    {
+        As              1.512e-06;
+        Ts              120;
+    }
+    elements
+    {
+        N               2;
+    }
+}
+
+O2
+{
+    specie
+    {
+        molWeight       31.9988;
+    }
+    thermodynamics
+    {
+        Tlow            200;
+        Thigh           3500;
+        Tcommon         1000;
+        highCpCoeffs    ( 3.28253784 0.00148308754 -7.57966669e-07 2.09470555e-10 -2.16717794e-14 -1088.45772 5.45323129 );
+        lowCpCoeffs     ( 3.78245636 -0.00299673416 9.84730201e-06 -9.68129509e-09 3.24372837e-12 -1063.94356 3.65767573 );
+    }
+    transport
+    {
+        As              1.512e-06;
+        Ts              120;
+    }
+    elements
+    {
+        O               2;
+    }
+}
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/thermophysicalProperties b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/thermophysicalProperties
new file mode 100644
index 0000000000000000000000000000000000000000..bd3639697dddb37cb94a254401fe90fc7bed5e1e
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/thermophysicalProperties
@@ -0,0 +1,38 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      thermophysicalProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+thermoType
+{
+
+    type            hePsiThermo;
+    mixture         reactingMixture;
+    transport       sutherland;
+    thermo          janaf;
+    energy          sensibleEnthalpy;
+    equationOfState perfectGas;
+    specie          specie;
+}
+
+inertSpecie N2;
+
+chemistryReader foamChemistryReader;
+foamChemistryFile "$FOAM_CASE/constant/reactionsGRI";
+foamChemistryThermoFile "$FOAM_CASE/constant/thermo.compressibleGasGRI";
+
+dpdt false;
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/turbulenceProperties b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/turbulenceProperties
new file mode 100644
index 0000000000000000000000000000000000000000..efd9fc389372314402724762bec5f38480d34a25
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/constant/turbulenceProperties
@@ -0,0 +1,33 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    location    "constant";
+    object      turbulenceProperties;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+simulationType   RAS;
+
+RAS
+{
+    RASModel        kEpsilon;
+
+    kEpsilonCoeffs
+    {
+        Prt 0.85;
+    }
+
+    turbulence      on;
+    printCoeffs     on;
+}
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/system/blockMeshDict b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/system/blockMeshDict
new file mode 100644
index 0000000000000000000000000000000000000000..accce4014840cdfd8c992818cc6b453094ab8376
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/system/blockMeshDict
@@ -0,0 +1,112 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version     2.0;
+    format      ascii;
+    class       dictionary;
+    object      blockMeshDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+convertToMeters 1;
+
+vertices
+(
+    (0.00  0.25  0)    //  0
+    (1.00  0.25  0)    //  1
+    (1.25  0.00  -0.6)    //  2
+    (2.25  0.00  -0.6)    //  3
+    (2.50  0.25  0)    //  4
+    (4.00  0.35  0.2)    //  5
+
+    (4.00  0.45  0.2)    //  6
+    (2.50  0.75  0)    //  7
+    (2.25  1.00  -0.6)    //  8
+    (1.25  1.00  -0.6)    //  9
+    (1.00  0.75  0)    // 10
+    (0.00  0.75  0)    // 11
+
+
+    (0.00  0.25  0.6)  // 12
+    (1.00  0.25  0.6)  // 13
+    (1.25  0.00  1.2)  // 14
+    (2.25  0.00  1.2)  // 15
+    (2.50  0.25  0.6)  // 16
+    (4.00  0.35  0.4)  // 17
+
+    (4.00  0.45  0.4)  // 18
+    (2.50  0.75  0.6)  // 19
+    (2.25  1.00  1.2)  // 20
+    (1.25  1.00  1.2)  // 21
+    (1.00  0.75  0.6)  // 22
+    (0.00  0.75  0.6)  // 23
+);
+
+blocks
+(
+    hex ( 0  1 10 11 12 13 22 23) (20 20 10) simpleGrading (1 1 1)
+    hex ( 1  2  9 10 13 14 21 22) ( 8 20 10) simpleGrading (1 1 1)
+    hex ( 2  3  8  9 14 15 20 21) (20 20 10) simpleGrading (1 1 1)
+    hex ( 3  5  6  8 15 17 18 20) (30 20 10) simpleGrading (1 1 1)
+);
+
+edges
+(
+);
+
+boundary
+(
+    walls
+    {
+        type wall;
+        faces
+        (
+            ( 0  1 13 12)
+            ( 1  2 14 13)
+            ( 2  3 15 14)
+            ( 3  5 17 15)
+            ( 6  8 20 18)
+            ( 8  9 21 20)
+            ( 9 10 22 21)
+            (10 11 23 22)
+            ( 0 11 10  1)
+            ( 1 10  9  2)
+            ( 2  9  8  3)
+            ( 3  8  6  5)
+            (12 13 22 23)
+            (13 14 21 22)
+            (14 15 20 21)
+            (15 17 18 20)
+
+        );
+    }
+
+    inletair
+    {
+        type patch;
+        faces
+        (
+            (11  0 12 23)
+        );
+    }
+
+    outlet
+    {
+        type patch;
+        faces
+        (
+            ( 5  6 18 17)
+        );
+    }
+
+
+);
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/system/controlDict b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/system/controlDict
new file mode 100644
index 0000000000000000000000000000000000000000..b03eb034234c814e8d65ea826555912871a89afd
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/system/controlDict
@@ -0,0 +1,54 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           dictionary;
+    location        "system";
+    object          controlDict;
+}
+
+application     reactingFoam;
+
+startFrom       startTime;
+
+startTime       0;
+
+stopAt          endTime;
+
+endTime         1;
+
+deltaT          1e-5;
+
+writeControl    adjustableRunTime;
+
+writeInterval   0.02;
+
+purgeWrite      0;
+
+writeFormat     ascii;
+
+writePrecision  10;
+
+writeCompression off;
+
+timeFormat      general;
+
+timePrecision   6;
+
+runTimeModifiable true;
+
+adjustTimeStep  yes;
+
+maxCo           0.3;
+
+maxDeltaT       0.25;
+
+// ************************************************************************* //
+
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/system/decomposeParDict b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/system/decomposeParDict
new file mode 100644
index 0000000000000000000000000000000000000000..54e28151b747efca10211d8c5d1f44459966fec3
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/system/decomposeParDict
@@ -0,0 +1,25 @@
+/*--------------------------------*- 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      decomposeParDict;
+}
+// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
+
+numberOfSubdomains 3;
+
+method          scotch;
+
+roots           ( );
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/system/fvSchemes b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/system/fvSchemes
new file mode 100644
index 0000000000000000000000000000000000000000..0fdec4a112117f271860017124470bb4b47adbfc
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/system/fvSchemes
@@ -0,0 +1,58 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           dictionary;
+    location        "system";
+    object          fvSchemes;
+}
+
+ddtSchemes
+{
+    default         Euler;
+}
+
+gradSchemes
+{
+    default         Gauss linear;
+    grad(U)         cellLimited Gauss linear 1;
+}
+
+divSchemes
+{
+    default         none;
+    div(phi,U)      Gauss limitedLinearV 1;
+    div(phi,Yi)     Gauss limitedLinear01 1;
+    div(phi,h)      Gauss limitedLinear 1;
+    div(phi,K)      Gauss limitedLinear 1;
+    div(phid,p)     Gauss limitedLinear 1;
+    div(phi,epsilon) Gauss upwind;
+    div(phi,Yi_h)   Gauss limitedLinear 1;
+    div(phi,k)      Gauss upwind;
+    div(((rho*nuEff)*dev2(T(grad(U))))) Gauss linear;
+}
+
+laplacianSchemes
+{
+    default         Gauss linear corrected;
+}
+
+interpolationSchemes
+{
+    default         linear;
+}
+
+snGradSchemes
+{
+    default         corrected;
+}
+
+
+// ************************************************************************* //
diff --git a/tutorials/combustion/reactingFoam/RAS/chockedNozzle/system/fvSolution b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/system/fvSolution
new file mode 100644
index 0000000000000000000000000000000000000000..0dbd157c85ac64647c70d3d87f9b7bb77c797a02
--- /dev/null
+++ b/tutorials/combustion/reactingFoam/RAS/chockedNozzle/system/fvSolution
@@ -0,0 +1,85 @@
+/*--------------------------------*- C++ -*----------------------------------*\
+| =========                 |                                                 |
+| \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
+|  \\    /   O peration     | Version:  dev                                   |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
+|    \\/     M anipulation  |                                                 |
+\*---------------------------------------------------------------------------*/
+FoamFile
+{
+    version         2;
+    format          ascii;
+    class           dictionary;
+    location        "system";
+    object          fvSolution;
+}
+
+solvers
+{
+    "rho.*"
+    {
+        solver          diagonal;
+    }
+    p
+    {
+        solver          GAMG;
+        tolerance       1e-07;
+        relTol          0.01;
+        smoother        GaussSeidel;
+        cacheAgglomeration true;
+        nCellsInCoarsestLevel 1;
+        agglomerator    faceAreaPair;
+        mergeLevels     1;
+    }
+    pFinal
+    {
+        solver          GAMG;
+        tolerance       1e-8;
+        relTol          0;
+        smoother        GaussSeidel;
+        cacheAgglomeration true;
+        nCellsInCoarsestLevel 1;
+        agglomerator    faceAreaPair;
+        mergeLevels     1;
+    }
+    "(U|h|k|epsilon)"
+    {
+        solver          PBiCGStab;
+        preconditioner  DILU;
+        tolerance       1e-06;
+        relTol          0.1;
+    }
+    "(U|h|k|epsilon)Final"
+    {
+        solver          PBiCGStab;
+        preconditioner  DILU;
+        tolerance       1e-7;
+        relTol          0;
+    }
+    Yi
+    {
+        solver          PBiCGStab;
+        preconditioner  DILU;
+        tolerance       1e-08;
+        relTol          0.1;
+    }
+}
+
+PIMPLE
+{
+    momentumPredictor no;
+    nOuterCorrectors 2;
+    nCorrectors     2;
+    nNonOrthogonalCorrectors 1;
+}
+
+relaxationFactors
+{
+    equations
+    {
+        ".*"            1;
+    }
+}
+
+
+// ************************************************************************* //