diff --git a/dumux/discretization/box/maxwellstefanslaw.hh b/dumux/discretization/box/maxwellstefanslaw.hh new file mode 100644 index 0000000000000000000000000000000000000000..e824a7da33d98f4fef35c9b3b4710f403457fc13 --- /dev/null +++ b/dumux/discretization/box/maxwellstefanslaw.hh @@ -0,0 +1,280 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program 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 2 of the License, or * + * (at your option) any later version. * + * * + * This program 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 this program. If not, see . * + *****************************************************************************/ +/*! + * \file + * \brief This file contains the data which is required to calculate + * diffusive mass fluxes due to molecular diffusion with Fick's law. + */ +#ifndef DUMUX_DISCRETIZATION_BOX_MAXWELL_STEFAN_LAW_HH +#define DUMUX_DISCRETIZATION_BOX_MAXWELL_STEFAN_LAW_HH + +#include + +#include +#include + +#include +#include + +namespace Dumux +{ + +namespace Properties +{ +// forward declaration of properties +NEW_PROP_TAG(NumPhases); +NEW_PROP_TAG(EffectiveDiffusivityModel); +} + +/*! + * \ingroup CCTpfaMaxwellStefansLaw + * \brief Specialization of Maxwell Stefan's Law for the Box method. + */ +template +class MaxwellStefansLawImplementation +{ + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem); + using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables); + using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); + using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); + using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); + using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using ElementFluxVariablesCache = typename GET_PROP_TYPE(TypeTag, ElementFluxVariablesCache); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using IndexType = typename GridView::IndexSet::IndexType; + using Indices = typename GET_PROP_TYPE(TypeTag, Indices); + using Element = typename GridView::template Codim<0>::Entity; + + enum { dim = GridView::dimension} ; + enum { dimWorld = GridView::dimensionworld} ; + enum + { + numPhases = GET_PROP_VALUE(TypeTag, NumPhases), + numComponents = GET_PROP_VALUE(TypeTag,NumComponents) + }; + using DimWorldMatrix = Dune::FieldMatrix; + using GlobalPosition = Dune::FieldVector; + using ComponentFluxVector = Dune::FieldVector; + using ReducedComponentVector = Dune::FieldVector; + using ReducedComponentMatrix = Dune::FieldMatrix; + +public: + static ComponentFluxVector flux(const Problem& problem, + const Element& element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolumeFace& scvf, + const int phaseIdx, + const ElementFluxVariablesCache& elemFluxVarsCache) + { + //this is to calculate the maxwellStefan diffusion in a multicomponent system. + //see: Multicomponent Mass Transfer. R. Taylor u. R. Krishna. J. Wiley & Sons, New York 1993 + ComponentFluxVector componentFlux(0.0); + ReducedComponentMatrix reducedDiffusionMatrix(0.0); + ReducedComponentVector reducedFlux(0.0); + ComponentFluxVector moleFrac(0.0); + ReducedComponentVector normalX(0.0); + + // evaluate gradX at integration point and interpolate density + const auto& fluxVarsCache = elemFluxVarsCache[scvf]; + const auto& jacInvT = fluxVarsCache.jacInvT(); + const auto& shapeJacobian = fluxVarsCache.shapeJacobian(); + const auto& shapeValues = fluxVarsCache.shapeValues(); + + Scalar rho(0.0); + std::vector gradN(fvGeometry.numScv()); + for (auto&& scv : scvs(fvGeometry)) + { + const auto& volVars = elemVolVars[scv]; + + // density interpolation + rho += volVars.molarDensity(phaseIdx)*shapeValues[scv.indexInElement()][0]; + // the ansatz function gradient + jacInvT.mv(shapeJacobian[scv.indexInElement()][0], gradN[scv.indexInElement()]); + + //interpolate the mole fraction for the diffusion matrix + for (int compIdx = 0; compIdx < numComponents; compIdx++) + { + moleFrac[compIdx] += volVars.moleFraction(phaseIdx, compIdx)*shapeValues[scv.indexInElement()][0]; + } + } + + reducedDiffusionMatrix = setupMSMatrix_(problem, element, fvGeometry, elemVolVars, scvf, phaseIdx, moleFrac); + + for (int compIdx = 0; compIdx < numComponents-1; compIdx++) + { + GlobalPosition gradX(0.0); + for (auto&& scv : scvs(fvGeometry)) + { + const auto& volVars = elemVolVars[scv]; + + // the mole/mass fraction gradient + gradX.axpy(volVars.moleFraction(phaseIdx, compIdx), gradN[scv.indexInElement()]); + } + + normalX[compIdx] = gradX *scvf.unitOuterNormal(); + } + reducedDiffusionMatrix.solve(reducedFlux,normalX); + reducedFlux *= -1.0*rho*scvf.area(); + + + for (int compIdx = 0; compIdx < numComponents-1; compIdx++) + { + componentFlux[compIdx] = reducedFlux[compIdx]; + componentFlux[numComponents-1] -= reducedFlux[compIdx]; + } + return componentFlux ; + } + +private: + + static ReducedComponentMatrix setupMSMatrix_(const Problem& problem, + const Element& element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolumeFace& scvf, + const int phaseIdx, + const ComponentFluxVector moleFrac) + { + + ReducedComponentMatrix reducedDiffusionMatrix(0.0); + + const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; + const auto& outsideVolVars = elemVolVars[scvf.outsideScvIdx()]; + const auto insideScvIdx = scvf.insideScvIdx(); + const auto outsideScvIdx = scvf.outsideScvIdx(); + //this is to not devide by 0 if the saturation in 0 and the effectiveDiffusivity becomes zero due to that + if(insideVolVars.saturation(phaseIdx) == 0 || outsideVolVars.saturation(phaseIdx) == 0) + return reducedDiffusionMatrix; + + for (int compIIdx = 0; compIIdx < numComponents-1; compIIdx++) + { + // effective diffusion tensors + using EffDiffModel = typename GET_PROP_TYPE(TypeTag, EffectiveDiffusivityModel); + + const auto xi = moleFrac[compIIdx]; + + //calculate diffusivity for i,numComponents + + auto tinInside = getDiffusionCoefficient(phaseIdx, compIIdx, numComponents-1, problem, element, insideVolVars, fvGeometry.scv(insideScvIdx)); + tinInside = EffDiffModel::effectiveDiffusivity(insideVolVars.porosity(), insideVolVars.saturation(phaseIdx), tinInside); + auto tinOutside = getDiffusionCoefficient(phaseIdx, compIIdx, numComponents-1, problem, element, outsideVolVars, fvGeometry.scv(outsideScvIdx)); + tinOutside = EffDiffModel::effectiveDiffusivity(insideVolVars.porosity(), insideVolVars.saturation(phaseIdx), tinOutside); + + // scale by extrusion factor + tinInside *= insideVolVars.extrusionFactor(); + tinOutside *= outsideVolVars.extrusionFactor(); + + // the resulting averaged diffusion tensor + const auto tin = problem.spatialParams().harmonicMean(tinInside, tinOutside, scvf.unitOuterNormal()); + + //set the entrys of the diffusion matrix of the diagonal + reducedDiffusionMatrix[compIIdx][compIIdx] += xi/tin; + + for (int compkIdx = 0; compkIdx < numComponents; compkIdx++) + { + if (compkIdx == compIIdx) + continue; + + const auto xk = moleFrac[compkIdx]; + + auto tikInside = getDiffusionCoefficient(phaseIdx, compIIdx, compkIdx, problem, element, insideVolVars, fvGeometry.scv(insideScvIdx)); + tikInside = EffDiffModel::effectiveDiffusivity(insideVolVars.porosity(), insideVolVars.saturation(phaseIdx), tikInside); + auto tikOutside = getDiffusionCoefficient(phaseIdx, compIIdx, compkIdx, problem, element, outsideVolVars, fvGeometry.scv(outsideScvIdx)); + tikOutside = EffDiffModel::effectiveDiffusivity(insideVolVars.porosity(), insideVolVars.saturation(phaseIdx), tikOutside); + + // scale by extrusion factor + tikInside *= insideVolVars.extrusionFactor(); + tikOutside *= outsideVolVars.extrusionFactor(); + + // the resulting averaged diffusion tensor + const auto tik = problem.spatialParams().harmonicMean(tikInside, tikOutside, scvf.unitOuterNormal()); + + reducedDiffusionMatrix[compIIdx][compIIdx] += xk/tik; + } + + // now set the rest of the entries (off-diagonal) + for (int compJIdx = 0; compJIdx < numComponents-1; compJIdx++) + { + //we don't want to calculate e.g. water in water diffusion + if (compIIdx == compJIdx) + continue; + //calculate diffusivity for compIIdx, compJIdx + auto tijInside = getDiffusionCoefficient(phaseIdx, compIIdx, compJIdx, problem, element, insideVolVars, fvGeometry.scv(insideScvIdx)); + tijInside = EffDiffModel::effectiveDiffusivity(insideVolVars.porosity(), insideVolVars.saturation(phaseIdx), tijInside); + auto tijOutside = getDiffusionCoefficient(phaseIdx, compIIdx, compJIdx, problem, element, outsideVolVars, fvGeometry.scv(outsideScvIdx)); + tijOutside = EffDiffModel::effectiveDiffusivity(insideVolVars.porosity(), outsideVolVars.saturation(phaseIdx), tijOutside); + + // scale by extrusion factor + tijInside *= insideVolVars.extrusionFactor(); + tijOutside *= outsideVolVars.extrusionFactor(); + + // the resulting averaged diffusion tensor + const auto tij = problem.spatialParams().harmonicMean(tijInside, tijOutside, scvf.unitOuterNormal()); + + reducedDiffusionMatrix[compIIdx][compJIdx] +=xi*(1/tin - 1/tij); + } + } + + return reducedDiffusionMatrix; + } + +private: + template =0 > + static Scalar getDiffusionCoefficient(const int phaseIdx, + const int compIIdx, + const int compJIdx, + const Problem& problem, + const Element& element, + const VolumeVariables& volVars, + const SubControlVolume& scv) + { + return FluidSystem::binaryDiffusionCoefficient(compIIdx, + compJIdx, + problem, + element, + scv); + } + + template =0 > + static Scalar getDiffusionCoefficient(const int phaseIdx, + const int compIIdx, + const int compJIdx, + const Problem& problem, + const Element& element, + const VolumeVariables& volVars, + const SubControlVolume& scv) + { + auto fluidState = volVars.fluidState(); + typename FluidSystem::ParameterCache paramCache; + paramCache.updateAll(fluidState); + return FluidSystem::binaryDiffusionCoefficient(fluidState, + paramCache, + phaseIdx, + compIIdx, + compJIdx); + } + +}; +} // end namespace + +#endif diff --git a/dumux/discretization/cellcentered/tpfa/maxwellstefanslaw.hh b/dumux/discretization/cellcentered/tpfa/maxwellstefanslaw.hh new file mode 100644 index 0000000000000000000000000000000000000000..82e2f9cee59d7044187182335d3672c5d1a61b87 --- /dev/null +++ b/dumux/discretization/cellcentered/tpfa/maxwellstefanslaw.hh @@ -0,0 +1,298 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program 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 2 of the License, or * + * (at your option) any later version. * + * * + * This program 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 this program. If not, see . * + *****************************************************************************/ +/*! + * \file + * \brief This file contains the data which is required to calculate + * diffusive mass fluxes due to molecular diffusion with Fick's law. + */ +#ifndef DUMUX_DISCRETIZATION_CC_TPFA_MAXWELL_STEFAN_LAW_HH +#define DUMUX_DISCRETIZATION_CC_TPFA_MAXWELL_STEFAN_LAW_HH + +#include + +#include +#include + +#include +#include + +namespace Dumux +{ + +namespace Properties +{ +// forward declaration of properties +NEW_PROP_TAG(NumPhases); +NEW_PROP_TAG(EffectiveDiffusivityModel); +} + +/*! + * \ingroup CCTpfaMaxwellStefansLaw + * \brief Specialization of Maxwell Stefan's Law for the CCTpfa method. + */ +template +class MaxwellStefansLawImplementation +{ + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using EffDiffModel = typename GET_PROP_TYPE(TypeTag, EffectiveDiffusivityModel); + using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); + using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using IndexType = typename GridView::IndexSet::IndexType; + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables); + using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); + using Element = typename GridView::template Codim<0>::Entity; + using ElementFluxVariablesCache = typename GET_PROP_TYPE(TypeTag, ElementFluxVariablesCache); + using FluxVariablesCache = typename GET_PROP_TYPE(TypeTag, FluxVariablesCache); + using Indices = typename GET_PROP_TYPE(TypeTag, Indices); + using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem); + + static const int dim = GridView::dimension; + static const int dimWorld = GridView::dimensionworld; + static const int numPhases = GET_PROP_VALUE(TypeTag, NumPhases); + static const int numComponents = GET_PROP_VALUE(TypeTag,NumComponents); + + using DimWorldMatrix = Dune::FieldMatrix; + using GlobalPosition = Dune::FieldVector; + using ComponentFluxVector = Dune::FieldVector; + using ReducedComponentVector = Dune::FieldVector; + using ReducedComponentMatrix = Dune::FieldMatrix; + +public: + // state the discretization method this implementation belongs to + static const DiscretizationMethods myDiscretizationMethod = DiscretizationMethods::CCTpfa; + + //! state the type for the corresponding cache and its filler + //! We don't cache anything for this law + using Cache = FluxVariablesCaching::EmptyDiffusionCache; + using CacheFiller = FluxVariablesCaching::EmptyCacheFiller; + + static ComponentFluxVector flux(const Problem& problem, + const Element& element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolumeFace& scvf, + const int phaseIdx, + const ElementFluxVariablesCache& elemFluxVarsCache) + { + //this is to calculate the maxwellStefan diffusion in a multicomponent system. + //see: Multicomponent Mass Transfer. R. Taylor u. R. Krishna. J. Wiley & Sons, New York 1993 + ComponentFluxVector componentFlux(0.0); + ReducedComponentVector moleFracInside(0.0); + ReducedComponentVector moleFracOutside(0.0); + ReducedComponentVector reducedFlux(0.0); + ReducedComponentMatrix reducedDiffusionMatrixInside(0.0); + ReducedComponentMatrix reducedDiffusionMatrixOutside(0.0); + + // get inside/outside volume variables + const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; + const auto& outsideVolVars = elemVolVars[scvf.outsideScvIdx()]; + const auto rhoInside = insideVolVars.molarDensity(phaseIdx); + const auto rhoOutside = outsideVolVars.molarDensity(phaseIdx); + //calculate the mole fraction vectors + for (int compIdx = 0; compIdx < numComponents-1; compIdx++) + { + //calculate x_inside + const auto xInside = insideVolVars.moleFraction(phaseIdx, compIdx); + //calculate outside molefraction with the respective transmissibility + const auto xOutside = outsideVolVars.moleFraction(phaseIdx, compIdx); + + moleFracInside[compIdx] = xInside; + moleFracOutside[compIdx] = xOutside; + } + + const auto insideScvIdx = scvf.insideScvIdx(); + const auto& insideScv = fvGeometry.scv(insideScvIdx); + const auto outsideScvIdx = scvf.outsideScvIdx(); + const auto& outsideScv = fvGeometry.scv(outsideScvIdx); + + //now we have to do the tpfa: J_i = J_j which leads to: tij(xi -xj) = -rho Bi^-1 omegai(x*-xi) with x* = (omegai Bi^-1 + omegaj Bj^-1)^-1 (xi omegai Bi^-1 + xj omegaj Bj^-1) with i inside and j outside + reducedDiffusionMatrixInside = setupMSMatrix_(problem, element, fvGeometry, insideVolVars, insideScv, phaseIdx); + + reducedDiffusionMatrixOutside = setupMSMatrix_(problem, element, fvGeometry, outsideVolVars, outsideScv, phaseIdx); + + //we cannot solve that if the matrix is 0 everywhere + if(!(insideVolVars.saturation(phaseIdx) == 0 || outsideVolVars.saturation(phaseIdx) == 0)) + { + + + const Scalar omegai = calculateOmega_(scvf, + insideScv, + insideVolVars.extrusionFactor()); + //if on boundary + if (scvf.boundary() || scvf.numOutsideScvs() > 1) + { + moleFracOutside -= moleFracInside; + reducedDiffusionMatrixInside.solve(reducedFlux, moleFracOutside); + reducedFlux *= omegai; + } + else + { + Scalar omegaj; + if (dim == dimWorld) + // assume the normal vector from outside is anti parallel so we save flipping a vector + omegaj = -1.0*calculateOmega_(scvf, + outsideScv, + outsideVolVars.extrusionFactor()); + else + omegaj = calculateOmega_(fvGeometry.flipScvf(scvf.index()), + outsideScv, + outsideVolVars.extrusionFactor()); + + reducedDiffusionMatrixInside.invert(); + reducedDiffusionMatrixOutside.invert(); + reducedDiffusionMatrixInside *= omegai; + reducedDiffusionMatrixOutside *= omegaj; + + //in the helpervector we store the values for x* + ReducedComponentVector helperVector(0.0); + ReducedComponentVector gradientVectori(0.0); + ReducedComponentVector gradientVectorj(0.0); + + reducedDiffusionMatrixInside.mv(moleFracInside, gradientVectori); + reducedDiffusionMatrixOutside.mv(moleFracOutside, gradientVectorj); + + auto gradientVectorij = (gradientVectori + gradientVectorj); + + //add the two matrixes to each other + reducedDiffusionMatrixOutside += reducedDiffusionMatrixInside; + + reducedDiffusionMatrixOutside.solve(helperVector, gradientVectorij); + + //Bi^-1 omegai rho(x*-xi) + helperVector -=moleFracInside; + reducedDiffusionMatrixInside.mv(helperVector, reducedFlux); + } + + reducedFlux *= -0.5*(rhoInside+rhoOutside)*scvf.area(); + for (int compIdx = 0; compIdx < numComponents-1; compIdx++) + { + componentFlux[compIdx] = reducedFlux[compIdx]; + componentFlux[numComponents-1] -=reducedFlux[compIdx]; + } + } + return componentFlux ; + } + +private: + static Scalar calculateOmega_(const SubControlVolumeFace& scvf, + const SubControlVolume &scv, + const Scalar extrusionFactor) + { + auto distanceVector = scvf.ipGlobal(); + distanceVector -= scv.center(); + distanceVector /= distanceVector.two_norm2(); + + Scalar omega = (distanceVector * scvf.unitOuterNormal()); + omega *= extrusionFactor; + + return omega; + } + + static ReducedComponentMatrix setupMSMatrix_(const Problem& problem, + const Element& element, + const FVElementGeometry& fvGeometry, + const VolumeVariables& volVars, + const SubControlVolume& scv, + const int phaseIdx) + { + ReducedComponentMatrix reducedDiffusionMatrix(0.0); + + //this is to not devide by 0 if the saturation in 0 and the effectiveDiffusivity becomes zero due to that + if(volVars.saturation(phaseIdx) == 0) + return reducedDiffusionMatrix; + + for (int compIIdx = 0; compIIdx < numComponents-1; compIIdx++) + { + const auto xi = volVars.moleFraction(phaseIdx, compIIdx); + + //calculate diffusivity for i,numComponents + Scalar tin = getDiffusionCoefficient(phaseIdx, compIIdx, numComponents-1, problem, element, volVars, scv); + tin = EffDiffModel::effectiveDiffusivity(volVars.porosity(), volVars.saturation(phaseIdx), tin); + //set the entrys of the diffusion matrix of the diagonal + reducedDiffusionMatrix[compIIdx][compIIdx] += xi/tin; + for (int compkIdx = 0; compkIdx < numComponents; compkIdx++) + { + if (compkIdx == compIIdx) + continue; + + const auto xk = volVars.moleFraction(phaseIdx, compkIdx); + Scalar tik = getDiffusionCoefficient(phaseIdx, compIIdx, compkIdx, problem, element, volVars, scv); + tik = EffDiffModel::effectiveDiffusivity(volVars.porosity(), volVars.saturation(phaseIdx), tik); + reducedDiffusionMatrix[compIIdx][compIIdx] += xk/tik; + } + + // now set the rest of the entries (off-diagonal) + for (int compJIdx = 0; compJIdx < numComponents-1; compJIdx++) + { + //we don't want to calculate e.g. water in water diffusion + if (compIIdx == compJIdx) + continue; + //calculate diffusivity for compIIdx, compJIdx + Scalar tij = getDiffusionCoefficient(phaseIdx, compIIdx, compJIdx, problem, element, volVars, scv); + tij = EffDiffModel::effectiveDiffusivity(volVars.porosity(), volVars.saturation(phaseIdx), tij); + reducedDiffusionMatrix[compIIdx][compJIdx] +=xi*(1/tin - 1/tij); + } + } + return reducedDiffusionMatrix; + } + + template =0 > + static Scalar getDiffusionCoefficient(const int phaseIdx, + const int compIIdx, + const int compJIdx, + const Problem& problem, + const Element& element, + const VolumeVariables& volVars, + const SubControlVolume& scv) + { + return FluidSystem::binaryDiffusionCoefficient(compIIdx, + compJIdx, + problem, + element, + scv); + } + + template =0 > + static Scalar getDiffusionCoefficient(const int phaseIdx, + const int compIIdx, + const int compJIdx, + const Problem& problem, + const Element& element, + const VolumeVariables& volVars, + const SubControlVolume& scv) + { + auto fluidState = volVars.fluidState(); + typename FluidSystem::ParameterCache paramCache; + paramCache.updateAll(fluidState); + return FluidSystem::binaryDiffusionCoefficient(fluidState, + paramCache, + phaseIdx, + compIIdx, + compJIdx); + } + + + +}; +} // end namespace + +#endif diff --git a/dumux/discretization/maxwellstefanslaw.hh b/dumux/discretization/maxwellstefanslaw.hh new file mode 100644 index 0000000000000000000000000000000000000000..624489d7f99259ed5300d4bbe42f0fcc92f68478 --- /dev/null +++ b/dumux/discretization/maxwellstefanslaw.hh @@ -0,0 +1,49 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program 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 2 of the License, or * + * (at your option) any later version. * + * * + * This program 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 this program. If not, see . * + *****************************************************************************/ +/*! + * \file + * \brief This file contains the data which is required to calculate + * diffusive mass fluxes due to molecular diffusion with Fick's law. + */ +#ifndef DUMUX_DISCRETIZATION_MAXWELL_STEFAN_LAW_HH +#define DUMUX_DISCRETIZATION_MAXWELL_STEFAN_LAW_HH + +#include + +namespace Dumux +{ +// forward declaration +template +class MaxwellStefansLawImplementation +{}; + +/*! + * \ingroup MaxwellStefansLaw + * \brief Evaluates the diffusive mass flux according to Maxwell Stafan's law + */ +template +using MaxwellStefansLaw = MaxwellStefansLawImplementation; + +} // end namespace + +#include +#include +#include + +#endif diff --git a/dumux/discretization/staggered/freeflow/maxwellstefanslaw.hh b/dumux/discretization/staggered/freeflow/maxwellstefanslaw.hh new file mode 100644 index 0000000000000000000000000000000000000000..ac537b0c1b358472f034cf01ee350173330d4d6e --- /dev/null +++ b/dumux/discretization/staggered/freeflow/maxwellstefanslaw.hh @@ -0,0 +1,265 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program 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 2 of the License, or * + * (at your option) any later version. * + * * + * This program 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 this program. If not, see . * + *****************************************************************************/ +/*! + * \file + * \brief This file contains the data which is required to calculate + * diffusive mass fluxes due to molecular diffusion with Fick's law. + */ +#ifndef DUMUX_DISCRETIZATION_STAGGERED_MAXWELL_STEFAN_LAW_HH +#define DUMUX_DISCRETIZATION_STAGGERED_MAXWELL_STEFAN_LAW_HH + +#include + +#include +#include + +#include +#include + +#include +namespace Dumux +{ + +/*! + * \ingroup StaggeredMaxwellStefansLaw + * \brief Specialization of Maxwell Stefan's Law for the Staggered method. + */ +template +class MaxwellStefansLawImplementation +{ + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); + using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); + using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables); + using CellCenterPrimaryVariables = typename GET_PROP_TYPE(TypeTag, CellCenterPrimaryVariables); + using Indices = typename GET_PROP_TYPE(TypeTag, Indices); + using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem); + + static const int dim = GridView::dimension; + static const int dimWorld = GridView::dimensionworld; + + static const int numComponents = GET_PROP_VALUE(TypeTag,NumComponents); + static constexpr bool useMoles = GET_PROP_VALUE(TypeTag, UseMoles); + + using ReducedComponentVector = Dune::FieldVector; + using ReducedComponentMatrix = Dune::FieldMatrix; + + static_assert(GET_PROP_VALUE(TypeTag, NumPhases) == 1, "Only one phase allowed supported!"); + + enum { + pressureIdx = Indices::pressureIdx, + conti0EqIdx = Indices::conti0EqIdx, + replaceCompEqIdx = Indices::replaceCompEqIdx, + phaseIdx = Indices::phaseIdx + }; + +public: + // state the discretization method this implementation belongs to + static const DiscretizationMethods myDiscretizationMethod = DiscretizationMethods::Staggered; + + //! state the type for the corresponding cache and its filler + //! We don't cache anything for this law + using Cache = FluxVariablesCaching::EmptyDiffusionCache; + using CacheFiller = FluxVariablesCaching::EmptyCacheFiller; + + static CellCenterPrimaryVariables diffusiveFluxForCellCenter(const Problem& problem, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolumeFace& scvf) + { + //this is to calculate the maxwellStefan diffusion in a multicomponent system. + //see: Multicomponent Mass Transfer. R. Taylor u. R. Krishna. J. Wiley & Sons, New York 1993 + CellCenterPrimaryVariables componentFlux(0.0); + ReducedComponentVector moleFracInside(0.0); + ReducedComponentVector moleFracOutside(0.0); + ReducedComponentVector reducedFlux(0.0); + ReducedComponentMatrix reducedDiffusionMatrixInside(0.0); + ReducedComponentMatrix reducedDiffusionMatrixOutside(0.0); + + // get inside/outside volume variables + const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; + const auto& outsideVolVars = elemVolVars[scvf.outsideScvIdx()]; + const auto rhoInside = insideVolVars.molarDensity(); + const auto rhoOutside = scvf.boundary() ? insideVolVars.molarDensity() : outsideVolVars.molarDensity(); + //calculate the mole fraction vectors + for (int compIdx = 0; compIdx < numComponents-1; compIdx++) + { + //calculate x_inside + const auto xInside = insideVolVars.moleFraction(phaseIdx, compIdx); + //calculate outside molefraction with the respective transmissibility + const auto xOutside = outsideVolVars.moleFraction(phaseIdx, compIdx); + + moleFracInside[compIdx] = xInside; + moleFracOutside[compIdx] = xOutside; + + // get equation index + const auto eqIdx = conti0EqIdx + compIdx; + + if(scvf.boundary()) + { + const auto bcTypes = problem.boundaryTypesAtPos(scvf.center()); + if(bcTypes.isOutflow(eqIdx) && eqIdx != pressureIdx) + return componentFlux; + } + } + + //now we have to do the tpfa: J_i = J_j which leads to: tij(xi -xj) = -rho Bi^-1 omegai(x*-xi) with x* = (omegai Bi^-1 + omegaj Bj^-1)^-1 (xi omegai Bi^-1 + xj omegaj Bj^-1) with i inside and j outside + reducedDiffusionMatrixInside = setupMSMatrix_(problem, fvGeometry, insideVolVars, scvf); + + reducedDiffusionMatrixOutside = setupMSMatrix_(problem, fvGeometry, outsideVolVars, scvf); + + const auto insideScvIdx = scvf.insideScvIdx(); + const auto& insideScv = fvGeometry.scv(insideScvIdx); + const auto outsideScvIdx = scvf.outsideScvIdx(); + const auto& outsideScv = fvGeometry.scv(outsideScvIdx); + + const Scalar omegai = calculateOmega_(scvf, + insideScv, + 1); + + //if on boundary + if (scvf.boundary()) + { + moleFracOutside -= moleFracInside; + reducedDiffusionMatrixInside.solve(reducedFlux, moleFracOutside); + reducedFlux *= omegai; + } + else + { + Scalar omegaj; + omegaj = -1.0*calculateOmega_(scvf, + outsideScv, + 1); + + reducedDiffusionMatrixInside.invert(); + reducedDiffusionMatrixOutside.invert(); + reducedDiffusionMatrixInside *= omegai; + reducedDiffusionMatrixOutside *= omegaj; + + //in the helpervector we store the values for x* + ReducedComponentVector helperVector(0.0); + ReducedComponentVector gradientVectori(0.0); + ReducedComponentVector gradientVectorj(0.0); + + reducedDiffusionMatrixInside.mv(moleFracInside, gradientVectori); + reducedDiffusionMatrixOutside.mv(moleFracOutside, gradientVectorj); + + auto gradientVectorij = (gradientVectori + gradientVectorj); + + //add the two matrixes to each other + reducedDiffusionMatrixOutside += reducedDiffusionMatrixInside; + + reducedDiffusionMatrixOutside.solve(helperVector, gradientVectorij); + + //Bi^-1 omegai rho(x*-xi) + helperVector -=moleFracInside; + reducedDiffusionMatrixInside.mv(helperVector, reducedFlux); + } + + reducedFlux *= -0.5*(rhoInside+rhoOutside)*scvf.area(); + + for (int compIdx = 0; compIdx < numComponents-1; compIdx++) + { + componentFlux[compIdx] = reducedFlux[compIdx]; + componentFlux[numComponents-1] -=reducedFlux[compIdx]; + } + + if(useMoles && replaceCompEqIdx <= numComponents) + componentFlux[replaceCompEqIdx] = 0.0; + + return componentFlux ; + } + +private: + static Scalar calculateOmega_(const SubControlVolumeFace& scvf, + const SubControlVolume &scv, + const Scalar extrusionFactor) + { + auto distanceVector = scvf.ipGlobal(); + distanceVector -= scv.center(); + distanceVector /= distanceVector.two_norm2(); + + Scalar omega = (distanceVector * scvf.unitOuterNormal()); + omega *= extrusionFactor; + + return omega; + } + + static ReducedComponentMatrix setupMSMatrix_(const Problem& problem, + const FVElementGeometry& fvGeometry, + const VolumeVariables& volVars, + const SubControlVolumeFace& scvf) + { + ReducedComponentMatrix reducedDiffusionMatrix(0.0); + + for (int compIIdx = 0; compIIdx < numComponents-1; compIIdx++) + { + const auto xi = volVars.moleFraction(phaseIdx, compIIdx); + + //calculate diffusivity for i,numComponents + auto fluidState = volVars.fluidState(); + typename FluidSystem::ParameterCache paramCache; + paramCache.updateAll(fluidState); + auto tin = FluidSystem::binaryDiffusionCoefficient(fluidState, + paramCache, + phaseIdx, + compIIdx, + numComponents-1); + //set the entrys of the diffusion matrix of the diagonal + reducedDiffusionMatrix[compIIdx][compIIdx] += xi/tin; + + for (int compkIdx = 0; compkIdx < numComponents; compkIdx++) + { + if (compkIdx == compIIdx) + continue; + + const auto xk = volVars.moleFraction(phaseIdx, compkIdx); + Scalar tik = FluidSystem::binaryDiffusionCoefficient(fluidState, + paramCache, + phaseIdx, + compIIdx, + compkIdx); + reducedDiffusionMatrix[compIIdx][compIIdx] += xk/tik; + } + + // now set the rest of the entries (off-diagonal) + for (int compJIdx = 0; compJIdx < numComponents-1; compJIdx++) + { + //we don't want to calculate e.g. water in water diffusion + if (compIIdx == compJIdx) + continue; + //calculate diffusivity for compIIdx, compJIdx + Scalar tij = FluidSystem::binaryDiffusionCoefficient(fluidState, + paramCache, + phaseIdx, + compIIdx, + compJIdx); + reducedDiffusionMatrix[compIIdx][compJIdx] +=xi*(1/tin - 1/tij); + } + } + return reducedDiffusionMatrix; + } +}; +} // end namespace + +#endif diff --git a/test/freeflow/navierstokesnc/CMakeLists.txt b/test/freeflow/navierstokesnc/CMakeLists.txt index 1c3742efe47cf20e71688e7c40b0361b6e794769..07cf0742c2936e0b3145250f53712d070dddde20 100644 --- a/test/freeflow/navierstokesnc/CMakeLists.txt +++ b/test/freeflow/navierstokesnc/CMakeLists.txt @@ -54,3 +54,12 @@ dune_add_test(NAME test_stokes2cni_diffusion --files ${CMAKE_SOURCE_DIR}/test/references/stokes2cni-diffusion.vtu ${CMAKE_CURRENT_BINARY_DIR}/test_stokes2cni_diffusion-00014.vtu --command "${CMAKE_CURRENT_BINARY_DIR}//test_stokes2cni test_stokes2cni_diffusion.input") + +dune_add_test(NAME test_msfreeflow + SOURCES test_msfreeflow.cc + CMAKE_GUARD HAVE_UMFPACK + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/maxwellstefanfreeflow-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_msfreeflow-00022.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_msfreeflow test_msfreeflow.input") diff --git a/test/freeflow/navierstokesnc/msfreeflowtestproblem.hh b/test/freeflow/navierstokesnc/msfreeflowtestproblem.hh new file mode 100644 index 0000000000000000000000000000000000000000..a3696e846aec6941b112d1ab0532529b8d644caf --- /dev/null +++ b/test/freeflow/navierstokesnc/msfreeflowtestproblem.hh @@ -0,0 +1,463 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program 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 2 of the License, or * + * (at your option) any later version. * + * * + * This program 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 this program. If not, see . * + *****************************************************************************/ +/*! + * \file + * + * \brief Channel flow test for the multi-component staggered grid (Navier-)Stokes model + */ +#ifndef DUMUX_CHANNEL_MAXWELL_STEFAN_TEST_PROBLEM_HH +#define DUMUX_CHANNEL_MAXWELL_STEFAN_TEST_PROBLEM_HH + +#include +#include + +#include +#include + +#include +#include + +#include + +namespace Dumux +{ +template +class MaxwellStefanNCTestProblem; + +namespace Properties { + +#if !NONISOTHERMAL +NEW_TYPE_TAG(MaxwellStefanNCTestProblem, INHERITS_FROM(StaggeredFreeFlowModel, NavierStokesNC)); +#else +NEW_TYPE_TAG(MaxwellStefanNCTestProblem, INHERITS_FROM(StaggeredFreeFlowModel, NavierStokesNCNI)); +#endif + +NEW_PROP_TAG(FluidSystem); + +SET_INT_PROP(MaxwellStefanNCTestProblem, ReplaceCompEqIdx, 0); + +// Set the grid type +SET_TYPE_PROP(MaxwellStefanNCTestProblem, Grid, Dune::YaspGrid<2>); + +// Set the problem property +SET_TYPE_PROP(MaxwellStefanNCTestProblem, Problem, Dumux::MaxwellStefanNCTestProblem ); + +SET_BOOL_PROP(MaxwellStefanNCTestProblem, EnableFVGridGeometryCache, true); + +SET_BOOL_PROP(MaxwellStefanNCTestProblem, EnableGridFluxVariablesCache, true); +SET_BOOL_PROP(MaxwellStefanNCTestProblem, EnableGridVolumeVariablesCache, true); + +SET_BOOL_PROP(MaxwellStefanNCTestProblem, UseMoles, true); + +// #if ENABLE_NAVIERSTOKES +SET_BOOL_PROP(MaxwellStefanNCTestProblem, EnableInertiaTerms, true); + +//! Here we set FicksLaw or MaxwellStefansLaw +SET_TYPE_PROP(MaxwellStefanNCTestProblem, MolecularDiffusionType, MaxwellStefansLaw); + + +//! A simple fluid system with one MaxwellStefan component +template +class MaxwellStefanFluidSystem: public FluidSystems::BaseFluidSystem> + +{ + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + typedef MaxwellStefanFluidSystem ThisType; + typedef FluidSystems::BaseFluidSystem Base; + +public: + //! The number of components + static constexpr int numPhases = 1; + static constexpr int numComponents = 3; + + static constexpr int H2Idx = 0;//first major component + static constexpr int N2Idx = 1;//second major component + static constexpr int CO2Idx = 2;//secondary component + + //! Human readable component name (index compIdx) (for vtk output) + static std::string componentName(int compIdx) + { return "MaxwellStefan_" + std::to_string(compIdx); } + + //! Human readable phase name (index phaseIdx) (for velocity vtk output) + static std::string phaseName(int phaseIdx = 0) + { return "Gas"; } + + //! Molar mass in kg/mol of the component with index compIdx + static Scalar molarMass(unsigned int compIdx) + { return 0.02896; } + + + using Base::binaryDiffusionCoefficient; + /*! + * \brief Given a phase's composition, temperature and pressure, + * return the binary diffusion coefficient \f$\mathrm{[m^2/s]}\f$ for components + * \f$i\f$ and \f$j\f$ in this phase. + * + * \param fluidState An arbitrary fluid state + * \param phaseIdx The index of the fluid phase to consider + * \param compIIdx The index of the first component to consider + * \param compJIdx The index of the second component to consider + */ + template + static Scalar binaryDiffusionCoefficient(const FluidState &fluidState, + int phaseIdx, + unsigned int compIIdx, + unsigned int compJIdx) + { + if (compIIdx > compJIdx) + { + using std::swap; + swap(compIIdx, compJIdx); + } + + if (compIIdx == H2Idx && compJIdx == N2Idx) + return 83.3e-6; + if (compIIdx == H2Idx && compJIdx == CO2Idx) + return 68.0e-6; + if (compIIdx == N2Idx && compJIdx == CO2Idx) + return 16.8e-6; + DUNE_THROW(Dune::InvalidStateException, + "Binary diffusion coefficient of components " + << compIIdx << " and " << compJIdx << " is undefined!\n"); + } + using Base::density; + /*! + * \brief Given a phase's composition, temperature, pressure, and + * the partial pressures of all components, return its + * density \f$\mathrm{[kg/m^3]}\f$. + * \param phaseIdx index of the phase + * \param fluidState the fluid state + * + */ + template + static Scalar density(const FluidState &fluidState, + const int phaseIdx) + { + return 1; + } + + using Base::viscosity; + /*! + * \brief Calculate the dynamic viscosity of a fluid phase \f$\mathrm{[Pa*s]}\f$ + * \param fluidState An arbitrary fluid state + * \param phaseIdx The index of the fluid phase to consider + */ + template + static Scalar viscosity(const FluidState &fluidState, + int phaseIdx) + { + return 1e-6; + } +}; + +SET_TYPE_PROP(MaxwellStefanNCTestProblem, FluidSystem, MaxwellStefanFluidSystem); + +} //end namespace Property +/*! + * \brief Test problem for the maxwell stefan model + \todo doc me! + */ +template +class MaxwellStefanNCTestProblem : public NavierStokesProblem +{ + using ParentType = NavierStokesProblem; + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem); + + // copy some indices for convenience + typedef typename GET_PROP_TYPE(TypeTag, Indices) Indices; + enum { + // Grid and world dimension + dim = GridView::dimension, + dimWorld = GridView::dimensionworld + }; + enum { + massBalanceIdx = Indices::massBalanceIdx, + compTwoIdx = FluidSystem::N2Idx, + compThreeIdx = FluidSystem::CO2Idx, + momentumBalanceIdx = Indices::momentumBalanceIdx, + momentumXBalanceIdx = Indices::momentumXBalanceIdx, + momentumYBalanceIdx = Indices::momentumYBalanceIdx, + pressureIdx = Indices::pressureIdx, + velocityXIdx = Indices::velocityXIdx, + velocityYIdx = Indices::velocityYIdx, + }; + + using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); + + using Element = typename GridView::template Codim<0>::Entity; + + using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); + + using GlobalPosition = Dune::FieldVector; + + using CellCenterPrimaryVariables = typename GET_PROP_TYPE(TypeTag, CellCenterPrimaryVariables); + using FacePrimaryVariables = typename GET_PROP_TYPE(TypeTag, FacePrimaryVariables); + + using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); + using SourceValues = typename GET_PROP_TYPE(TypeTag, NumEqVector); + + using GridVariables = typename GET_PROP_TYPE(TypeTag, GridVariables); + using SolutionVector = typename GET_PROP_TYPE(TypeTag, SolutionVector); + using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables); + using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); + +public: + MaxwellStefanNCTestProblem(std::shared_ptr fvGridGeometry) + : ParentType(fvGridGeometry), eps_(1e-6) + { + name_ = getParam("Problem.Name"); + plotOutput_ = false; + } + + /*! + * \name Problem parameters + */ + // \{ + + /*! + * \brief The problem name. + * + * This is used as a prefix for files generated by the simulation. + */ + std::string name() const + { + return name_; + } + + bool shouldWriteRestartFile() const + { + return false; + } + + //! Called after every time step + //! Output the diffusion rates from left to right + void postTimeStep(const SolutionVector& curSol, + const GridVariables& gridVariables, + Scalar time) + { + + if (plotOutput_) + { + Scalar x_co2_left = 0.0; + Scalar x_n2_left = 0.0; + Scalar x_co2_right = 0.0; + Scalar x_n2_right = 0.0; + Scalar x_h2_left = 0.0; + Scalar x_h2_right = 0.0; + Scalar i = 0.0; + Scalar j = 0.0; + for (const auto& element : elements(this->fvGridGeometry().gridView())) + { + auto fvGeometry = localView(this->fvGridGeometry()); + fvGeometry.bindElement(element); + + auto elemVolVars = localView(gridVariables.curGridVolVars()); + elemVolVars.bind(element, fvGeometry, curSol); + for (auto&& scv : scvs(fvGeometry)) + { + const auto globalPos = scv.dofPosition(); + + if (globalPos[0] < 0.5) + { + x_co2_left += elemVolVars[scv].moleFraction(0,2); + + x_n2_left += elemVolVars[scv].moleFraction(0,1); + x_h2_left += elemVolVars[scv].moleFraction(0,0); + i +=1; + } + else + { + x_co2_right += elemVolVars[scv].moleFraction(0,2); + x_n2_right += elemVolVars[scv].moleFraction(0,1); + x_h2_right += elemVolVars[scv].moleFraction(0,0); + j +=1; + } + + } + } + x_co2_left /= i; + x_n2_left /= i; + x_h2_left /= i; + x_co2_right /= j; + x_n2_right /= j; + x_h2_right /= j; + + //do a gnuplot + x_.push_back(time); // in seconds + y_.push_back(x_n2_left); + y2_.push_back(x_n2_right); + y3_.push_back(x_co2_left); + y4_.push_back(x_co2_right); + y5_.push_back(x_h2_left); + y6_.push_back(x_h2_right); + + gnuplot_.resetPlot(); + gnuplot_.setXRange(0, std::max(time, 72000.0)); + gnuplot_.setYRange(0.4, 0.6); + gnuplot_.setXlabel("time [s]"); + gnuplot_.setYlabel("mole fraction mol/mol"); + gnuplot_.addDataSetToPlot(x_, y_, "N2 left"); + gnuplot_.addDataSetToPlot(x_, y2_, "N2 right"); + gnuplot_.plot("mole_fraction_N2"); + + gnuplot2_.resetPlot(); + gnuplot2_.setXRange(0, std::max(time, 72000.0)); + gnuplot2_.setYRange(0.0, 0.6); + gnuplot2_.setXlabel("time [s]"); + gnuplot2_.setYlabel("mole fraction mol/mol"); + gnuplot2_.addDataSetToPlot(x_, y3_, "C02 left"); + gnuplot2_.addDataSetToPlot(x_, y4_, "C02 right"); + gnuplot2_.plot("mole_fraction_C02"); + + gnuplot3_.resetPlot(); + gnuplot3_.setXRange(0, std::max(time, 72000.0)); + gnuplot3_.setYRange(0.0, 0.6); + gnuplot3_.setXlabel("time [s]"); + gnuplot3_.setYlabel("mole fraction mol/mol"); + gnuplot3_.addDataSetToPlot(x_, y5_, "H2 left"); + gnuplot3_.addDataSetToPlot(x_, y6_, "H2 right"); + gnuplot3_.plot("mole_fraction_H2"); + } + + } + + /*! + * \brief Return the temperature within the domain in [K]. + * + * This problem assumes a temperature of 10 degrees Celsius. + */ + Scalar temperature() const + { return 273.15 + 10; } // 10C + + /*! + * \brief Return the sources within the domain. + * + * \param globalPos The global position + */ + SourceValues sourceAtPos(const GlobalPosition &globalPos) const + { + return SourceValues(0.0); + } + + // \} + /*! + * \name Boundary conditions + */ + // \{ + + /*! + * \brief Specifies which kind of boundary condition should be + * used for which equation on a given boundary control volume. + * + * \param globalPos The position of the center of the finite volume + */ + BoundaryTypes boundaryTypesAtPos(const GlobalPosition &globalPos) const + { + BoundaryTypes values; + values.setAllNeumann(); + // set Dirichlet values for the velocity everywhere + values.setDirichlet(momentumBalanceIdx); + values.setDirichlet(massBalanceIdx); + return values; + } + + /*! + * \brief Evaluate the boundary conditions for a dirichlet + * control volume. + * + * \param globalPos The center of the finite volume which ought to be set. + */ + PrimaryVariables dirichletAtPos(const GlobalPosition &globalPos) const + { + PrimaryVariables values = initialAtPos(globalPos); + return values; + + } + + /*! + * \name Volume terms + */ + // \{ + + /*! + * \brief Evaluate the initial value for a control volume. + * + * \param globalPos The global position + */ + PrimaryVariables initialAtPos(const GlobalPosition &globalPos) const + { + PrimaryVariables initialValues(0.0); + if (globalPos[0] < 0.5) + { + initialValues[compTwoIdx] = 0.50086; + initialValues[compThreeIdx] = 0.49914; + } + else + { + initialValues[compTwoIdx] = 0.49879; + initialValues[compThreeIdx] = 0.0; + } + + initialValues[pressureIdx] = 1.1e+5; + initialValues[velocityYIdx] = 0.0; + + return initialValues; + } + +private: + + bool isInlet(const GlobalPosition& globalPos) const + { + return globalPos[0] < eps_; + } + + bool isOutlet(const GlobalPosition& globalPos) const + { + return globalPos[0] > this->bBoxMax()[0] - eps_; + } + + bool isWall(const GlobalPosition& globalPos) const + { + return globalPos[0] > eps_ || globalPos[0] < this->bBoxMax()[0] - eps_; + } + + bool plotOutput_; + + const Scalar eps_{1e-6}; + std::string name_; + + Dumux::GnuplotInterface gnuplot_; + Dumux::GnuplotInterface gnuplot2_; + Dumux::GnuplotInterface gnuplot3_; + + std::vector x_; + std::vector y_; + std::vector y2_; + std::vector y3_; + std::vector y4_; + std::vector y5_; + std::vector y6_; +}; +} //end namespace + +#endif diff --git a/test/freeflow/navierstokesnc/test_msfreeflow.cc b/test/freeflow/navierstokesnc/test_msfreeflow.cc new file mode 100644 index 0000000000000000000000000000000000000000..af2672b58acf11b6e1196a7884da99047219ce2a --- /dev/null +++ b/test/freeflow/navierstokesnc/test_msfreeflow.cc @@ -0,0 +1,261 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program 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 2 of the License, or * + * (at your option) any later version. * + * * + * This program 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 this program. If not, see . * + *****************************************************************************/ +/*! + * \file + * + * \brief Test for the staggered grid multi-component (Navier-)Stokes model + */ + #include + + #include + #include + + #include + #include + #include + #include + #include + +#include "msfreeflowtestproblem.hh" + +#include +#include +#include +#include +#include + +#include +#include +#include + +#include +#include +#include + +#include + +#include + +/*! + * \brief Provides an interface for customizing error messages associated with + * reading in parameters. + * + * \param progName The name of the program, that was tried to be started. + * \param errorMsg The error message that was issued by the start function. + * Comprises the thing that went wrong and a general help message. + */ +void usage(const char *progName, const std::string &errorMsg) +{ + if (errorMsg.size() > 0) { + std::string errorMessageOut = "\nUsage: "; + errorMessageOut += progName; + errorMessageOut += " [options]\n"; + errorMessageOut += errorMsg; + errorMessageOut += "\n\nThe list of mandatory arguments for this program is:\n" + "\t-TimeManager.TEnd End of the simulation [s] \n" + "\t-TimeManager.DtInitial Initial timestep size [s] \n" + "\t-Grid.File Name of the file containing the grid \n" + "\t definition in DGF format\n" + "\t-SpatialParams.LensLowerLeftX x-coordinate of the lower left corner of the lens [m] \n" + "\t-SpatialParams.LensLowerLeftY y-coordinate of the lower left corner of the lens [m] \n" + "\t-SpatialParams.LensUpperRightX x-coordinate of the upper right corner of the lens [m] \n" + "\t-SpatialParams.LensUpperRightY y-coordinate of the upper right corner of the lens [m] \n" + "\t-SpatialParams.Permeability Permeability of the domain [m^2] \n" + "\t-SpatialParams.PermeabilityLens Permeability of the lens [m^2] \n"; + + std::cout << errorMessageOut + << "\n"; + } +} + +int main(int argc, char** argv) try +{ + using namespace Dumux; + + // define the type tag for this problem + using TypeTag = TTAG(MaxwellStefanNCTestProblem); + + // initialize MPI, finalize is done automatically on exit + const auto& mpiHelper = Dune::MPIHelper::instance(argc, argv); + + // print dumux start message + if (mpiHelper.rank() == 0) + DumuxMessage::print(/*firstCall=*/true); + + // parse command line arguments and input file + Parameters::init(argc, argv, usage); + + // try to create a grid (from the given grid file or the input file) + using GridCreator = typename GET_PROP_TYPE(TypeTag, GridCreator); + GridCreator::makeGrid(); + GridCreator::loadBalance(); + + //////////////////////////////////////////////////////////// + // run instationary non-linear problem on this grid + //////////////////////////////////////////////////////////// + + // we compute on the leaf grid view + const auto& leafGridView = GridCreator::grid().leafGridView(); + + // create the finite volume grid geometry + using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry); + auto fvGridGeometry = std::make_shared(leafGridView); + fvGridGeometry->update(); + + // the problem (initial and boundary conditions) + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + auto problem = std::make_shared(fvGridGeometry); + + // get some time loop parameters + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + const auto tEnd = getParam("TimeLoop.TEnd"); + const auto maxDivisions = getParam("TimeLoop.MaxTimeStepDivisions"); + const auto maxDt = getParam("TimeLoop.MaxTimeStepSize"); + auto dt = getParam("TimeLoop.DtInitial"); + + // check if we are about to restart a previously interrupted simulation + Scalar restartTime = 0; + if (Parameters::getTree().hasKey("Restart") || Parameters::getTree().hasKey("TimeLoop.Restart")) + restartTime = getParam("TimeLoop.Restart"); + + // instantiate time loop + auto timeLoop = std::make_shared>(restartTime, dt, tEnd); + timeLoop->setMaxTimeStepSize(maxDt); + + // the solution vector + using SolutionVector = typename GET_PROP_TYPE(TypeTag, SolutionVector); + using DofTypeIndices = typename GET_PROP(TypeTag, DofTypeIndices); + typename DofTypeIndices::CellCenterIdx cellCenterIdx; + typename DofTypeIndices::FaceIdx faceIdx; + const auto numDofsCellCenter = leafGridView.size(0); + const auto numDofsFace = leafGridView.size(1); + SolutionVector x; + x[cellCenterIdx].resize(numDofsCellCenter); + x[faceIdx].resize(numDofsFace); + problem->applyInitialSolution(x); + auto xOld = x; + + // the grid variables + using GridVariables = typename GET_PROP_TYPE(TypeTag, GridVariables); + auto gridVariables = std::make_shared(problem, fvGridGeometry); + gridVariables->init(x, xOld); + + // intialize the vtk output module + using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields); + StaggeredVtkOutputModule vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name()); + VtkOutputFields::init(vtkWriter); //! Add model specific output fields + vtkWriter.write(0.0); + + // the assembler with time loop for instationary problem + using Assembler = StaggeredFVAssembler; + auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop); + + // the linear solver + using LinearSolver = Dumux::UMFPackBackend; + auto linearSolver = std::make_shared(); + + // the non-linear solver + using NewtonController = StaggeredNewtonController; + using NewtonMethod = Dumux::NewtonMethod; + auto newtonController = std::make_shared(leafGridView.comm(), timeLoop); + NewtonMethod nonLinearSolver(newtonController, assembler, linearSolver); + + // time loop + timeLoop->start(); do + { + // set previous solution for storage evaluations + assembler->setPreviousSolution(xOld); + + // try solving the non-linear system + for (int i = 0; i < maxDivisions; ++i) + { + // linearize & solve + auto converged = nonLinearSolver.solve(x); + + if (converged) + break; + + if (!converged && i == maxDivisions-1) + DUNE_THROW(Dune::MathError, + "Newton solver didn't converge after " + << maxDivisions + << " time-step divisions. dt=" + << timeLoop->timeStepSize() + << ".\nThe solutions of the current and the previous time steps " + << "have been saved to restart files."); + } + + // make the new solution the old solution + xOld = x; + gridVariables->advanceTimeStep(); + problem->postTimeStep(x, *gridVariables,timeLoop->time()+timeLoop->timeStepSize()); + + // advance to the time loop to the next step + timeLoop->advanceTimeStep(); + + // write vtk output + vtkWriter.write(timeLoop->time()); + + // report statistics of this time step + timeLoop->reportTimeStep(); + + // set new dt as suggested by newton controller + timeLoop->setTimeStepSize(newtonController->suggestTimeStepSize(timeLoop->timeStepSize())); + + } while (!timeLoop->finished()); + + timeLoop->finalize(leafGridView.comm()); + + //////////////////////////////////////////////////////////// + // finalize, print dumux message to say goodbye + //////////////////////////////////////////////////////////// + + // print dumux end message + if (mpiHelper.rank() == 0) + { + Parameters::print(); + DumuxMessage::print(/*firstCall=*/false); + } + + return 0; +} // end main +catch (Dumux::ParameterException &e) +{ + std::cerr << std::endl << e << " ---> Abort!" << std::endl; + return 1; +} +catch (Dune::DGFException & e) +{ + std::cerr << "DGF exception thrown (" << e << + "). Most likely, the DGF file name is wrong " + "or the DGF file is corrupted, " + "e.g. missing hash at end of file or wrong number (dimensions) of entries." + << " ---> Abort!" << std::endl; + return 2; +} +catch (Dune::Exception &e) +{ + std::cerr << "Dune reported error: " << e << " ---> Abort!" << std::endl; + return 3; +} +catch (...) +{ + std::cerr << "Unknown exception thrown! ---> Abort!" << std::endl; + return 4; +} diff --git a/test/freeflow/navierstokesnc/test_msfreeflow.input b/test/freeflow/navierstokesnc/test_msfreeflow.input new file mode 100644 index 0000000000000000000000000000000000000000..b82489c0658c1cf67bd196a13be95fca1435d29b --- /dev/null +++ b/test/freeflow/navierstokesnc/test_msfreeflow.input @@ -0,0 +1,19 @@ +[TimeLoop] +DtInitial = 1 # [s] +TEnd = 70000 # [s] +MaxTimeStepSize = 1e6 + +[Grid] +UpperRight = 1 1 +Cells = 30 30 + +[Problem] +Name = test_msfreeflow # name passed to the output routines +EnableGravity = false + +[ Newton ] +MaxSteps = 10 +MaxRelativeShift = 1e-8 + +[Vtk] +WriteFaceData = false diff --git a/test/porousmediumflow/2pnc/implicit/2pncdiffusion.hh b/test/porousmediumflow/2pnc/implicit/2pncdiffusion.hh new file mode 100644 index 0000000000000000000000000000000000000000..6cffe8fc595f82d2aee6093fe3e262c59789b60c --- /dev/null +++ b/test/porousmediumflow/2pnc/implicit/2pncdiffusion.hh @@ -0,0 +1,264 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program 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 2 of the License, or * + * (at your option) any later version. * + * * + * This program 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 this program. If not, see . * + *****************************************************************************/ +/*! + * \file + * \ingroup TwoPNCTest + * \brief Problem where air is injected under a low permeable layer in a depth of 2700m. + */ +#ifndef DUMUX_TWOPNC_DIFFUSION_PROBLEM_HH +#define DUMUX_TWOPNC_DIFFUSION_PROBLEM_HH + +#include +#include +#include +#include +#include + +#include "2pncdiffusionspatialparams.hh" +#include + +namespace Dumux +{ + +template +class TwoPNCDiffusionProblem; + +namespace Properties +{ +NEW_TYPE_TAG(TwoPNCDiffusionProblem, INHERITS_FROM(TwoPNC, TwoPNCDiffusionSpatialParams)); +NEW_TYPE_TAG(TwoPNCDiffusionCCProblem, INHERITS_FROM(CCTpfaModel, TwoPNCDiffusionProblem)); + +// Set the grid type +SET_TYPE_PROP(TwoPNCDiffusionProblem, Grid, Dune::YaspGrid<2>); + +// Set the problem property +SET_TYPE_PROP(TwoPNCDiffusionProblem, Problem, TwoPNCDiffusionProblem); + +// // Set fluid configuration +SET_TYPE_PROP(TwoPNCDiffusionProblem, + FluidSystem, + FluidSystems::H2ON2); + +// Define whether mole(true) or mass (false) fractions are used +SET_BOOL_PROP(TwoPNCDiffusionProblem, UseMoles, true); + +//! Here we set FicksLaw or TwoPNCDiffusionsLaw +SET_TYPE_PROP(TwoPNCDiffusionProblem, MolecularDiffusionType, DIFFUSIONTYPE); + +//! Set the default formulation to pw-Sn: This can be over written in the problem. +SET_INT_PROP(TwoPNCDiffusionProblem, Formulation, TwoPNCFormulation::pwsn); +} + + +/*! + * \ingroup TwoPNCTest + * \brief DOC_ME + */ +template +class TwoPNCDiffusionProblem : public PorousMediumFlowProblem +{ + using ParentType = PorousMediumFlowProblem; + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem); + + enum { + // Grid and world dimension + dim = GridView::dimension, + dimWorld = GridView::dimensionworld + }; + + // copy some indices for convenience + using Indices = typename GET_PROP_TYPE(TypeTag, Indices); + enum { + wPhaseIdx = Indices::wPhaseIdx, + nPhaseIdx = Indices::nPhaseIdx, + + wCompIdx = FluidSystem::wCompIdx, + nCompIdx = FluidSystem::nCompIdx, + + contiH2OEqIdx = Indices::contiWEqIdx, + contiN2EqIdx = Indices::contiNEqIdx + }; + + using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); + using NeumannFluxes = typename GET_PROP_TYPE(TypeTag, NumEqVector); + using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); + using GlobalPosition = Dune::FieldVector; + using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry); + + //! property that defines whether mole or mass fractions are used + static const bool useMoles = GET_PROP_VALUE(TypeTag, UseMoles); + +public: + /*! + * \brief The constructor + * + * \param timeManager The time manager + * \param gridView The grid view + */ + TwoPNCDiffusionProblem(std::shared_ptr fvGridGeometry) + : ParentType(fvGridGeometry) + { + // initialize the tables of the fluid system + FluidSystem::init(); + + name_ = getParam("Problem.Name"); + + //stateing in the console whether mole or mass fractions are used + if(useMoles) + { + std::cout<<"problem uses mole-fractions"<fvGridGeometry().bBoxMin()[0] + eps_) + priVars[Indices::switchIdx] = 1e-3; + + return priVars; + } + + /*! + * \brief Evaluate the boundary conditions for a Neumann + * boundary segment. + * + * For this method, the \a priVars parameter stores the mass flux + * in normal direction of each component. Negative values mean + * influx. + * + * The units must be according to either using mole or mass fractions. (mole/(m^2*s) or kg/(m^2*s)) + */ + NeumannFluxes neumannAtPos(const GlobalPosition& globalPos) const + { + NeumannFluxes values(0.0); + return values; + } + + // \} + + /*! + * \name Volume terms + */ + // \{ + + /*! + * \brief Evaluates the initial values for a control volume + * + * \param values Stores the initial values for the conservation equations in + * \f$ [ \textnormal{unit of primary variables} ] \f$ + * \param globalPos The global position + */ + PrimaryVariables initialAtPos(const GlobalPosition &globalPos) const + { + return initial_(globalPos); + } + + // \} + +private: + /*! + * \brief Evaluates the initial values for a control volume + * + * The internal method for the initial condition + * + * \param values Stores the initial values for the conservation equations in + * \f$ [ \textnormal{unit of primary variables} ] \f$ + * \param globalPos The global position + */ + PrimaryVariables initial_(const GlobalPosition &globalPos) const + { + PrimaryVariables priVars(0.0); + priVars.setState(Indices::wPhaseOnly); + + //mole-fraction formulation + priVars[Indices::switchIdx] = 1e-5; + priVars[Indices::pressureIdx] = 1e5; + return priVars; + } + + Scalar temperature_; + static constexpr Scalar eps_ = 1e-6; + + std::string name_ ; + + +}; + +} //end namespace Dumux + +#endif diff --git a/test/porousmediumflow/2pnc/implicit/2pncdiffusionspatialparams.hh b/test/porousmediumflow/2pnc/implicit/2pncdiffusionspatialparams.hh new file mode 100644 index 0000000000000000000000000000000000000000..4ea817a75577408987553db2c218167c57de666a --- /dev/null +++ b/test/porousmediumflow/2pnc/implicit/2pncdiffusionspatialparams.hh @@ -0,0 +1,149 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program 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 2 of the License, or * + * (at your option) any later version. * + * * + * This program 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 this program. If not, see . * + *****************************************************************************/ +/*! + * \file + * \ingroup TwoPNCTest + * \brief Definition of the spatial parameters for the fuel cell + * problem which uses the isothermal/non-insothermal 2pnc box model + */ + +#ifndef DUMUX_TWOPNC_DIFFUSION_SPATIAL_PARAMS_HH +#define DUMUX_TWOPNC_DIFFUSION_SPATIAL_PARAMS_HH + +#include +#include +#include +#include +#include + +namespace Dumux +{ + +//forward declaration +template +class TwoPNCDiffusionSpatialParams; + +namespace Properties +{ +// The spatial parameters TypeTag +NEW_TYPE_TAG(TwoPNCDiffusionSpatialParams); + +// Set the spatial parameters +SET_TYPE_PROP(TwoPNCDiffusionSpatialParams, SpatialParams, TwoPNCDiffusionSpatialParams); + +// Set the material Law +SET_PROP(TwoPNCDiffusionSpatialParams, MaterialLaw) +{ +private: + // define the material law which is parameterized by effective + // saturations + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using EffectiveLaw = RegularizedBrooksCorey; +public: + // define the material law parameterized by absolute saturations + using type = EffToAbsLaw; +}; + +} // end namespace Properties + +/*! + * \ingroup TwoPNCTest + * \brief Definition of the spatial parameters for the TwoPNCDiffusion + * problem which uses the isothermal 2p2c box model + */ +template +class TwoPNCDiffusionSpatialParams : public FVSpatialParams +{ + using ParentType = FVSpatialParams; + + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using CoordScalar = typename GridView::ctype; + + static constexpr int dim = GridView::dimension; + static constexpr int dimWorld = GridView::dimensionworld; + + using GlobalPosition = Dune::FieldVector; + using DimWorldMatrix = Dune::FieldMatrix; + +public: + using PermeabilityType = DimWorldMatrix; + + using MaterialLaw = typename GET_PROP_TYPE(TypeTag, MaterialLaw); + using MaterialLawParams = typename MaterialLaw::Params; + + /*! + * \brief The constructor + * + * \param gridView The grid view + */ + TwoPNCDiffusionSpatialParams(const Problem& problem) + : ParentType(problem), K_(0) + { + // intrinsic permeabilities + K_[0][0] = 5e-11; + K_[1][1] = 5e-11; + + // porosities + porosity_ = 0.2; + + // residual saturations + materialParams_.setSwr(0.02); //here water, see philtophoblaw + materialParams_.setSnr(0.0); + + //parameters for the vanGenuchten law + materialParams_.setPe(1e2); // alpha = 1/pcb + materialParams_.setLambda(1.3); + } + + /*! + * \brief Returns the hydraulic conductivity \f$[m^2]\f$ + * + * \param globalPos The global position + */ + DimWorldMatrix permeabilityAtPos(const GlobalPosition& globalPos) const + { return K_; } + + /*! + * \brief Define the porosity \f$[-]\f$ of the spatial parameters + * + * \param globalPos The global position + */ + Scalar porosityAtPos(const GlobalPosition& globalPos) const + { return 0.2; } + + /*! + * \brief return the parameter object for the Brooks-Corey material law which depends on the position + * + * \param globalPos The global position + */ + const MaterialLawParams& materialLawParamsAtPos(const GlobalPosition& globalPos) const + { return materialParams_; } + +private: + DimWorldMatrix K_; + Scalar porosity_; + static constexpr Scalar eps_ = 1e-6; + MaterialLawParams materialParams_; +}; + +}//end namespace + +#endif diff --git a/test/porousmediumflow/2pnc/implicit/CMakeLists.txt b/test/porousmediumflow/2pnc/implicit/CMakeLists.txt index e533a50b90b0b19dc49528a4ca3ff47bbff3f344..6b5d5ba73229a4cf3451254e458ed665e50ed17d 100644 --- a/test/porousmediumflow/2pnc/implicit/CMakeLists.txt +++ b/test/porousmediumflow/2pnc/implicit/CMakeLists.txt @@ -1,4 +1,4 @@ -dune_symlink_to_source_files(FILES test_2pnc_fv.input) +dune_symlink_to_source_files(FILES test_2pnc_fv.input test_2pnc_diffusion.input) # isothermal tests dune_add_test(NAME test_2pnc_box @@ -19,10 +19,32 @@ dune_add_test(NAME test_2pnc_tpfa ${CMAKE_CURRENT_BINARY_DIR}/fuelcell_tpfa-00015.vtu --command "${CMAKE_CURRENT_BINARY_DIR}/test_2pnc_tpfa -ParameterFile test_2pnc_fv.input -Problem.Name fuelcell_tpfa") +dune_add_test(NAME test_cc2pnc_maxwellstefan + SOURCES test_cc2pnc_diffusion.cc + COMPILE_DEFINITIONS TYPETAG=TwoPNCDiffusionProblem DIFFUSIONTYPE=MaxwellStefansLaw + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/2pncdiffusioncc-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_cc2pnc_maxwellstefan-00026.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_cc2pnc_maxwellstefan test_2pnc_diffusion.input -Problem.Name test_cc2pnc_maxwellstefan") + +dune_add_test(NAME test_cc2pnc_fickslaw + SOURCES test_cc2pnc_diffusion.cc + COMPILE_DEFINITIONS TYPETAG=TwoPNCDiffusionProblem DIFFUSIONTYPE=FicksLaw + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/2pncdiffusioncc-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_cc2pnc_fickslaw-00026.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_cc2pnc_fickslaw test_2pnc_diffusion.input -Problem.Name test_cc2pnc_fickslaw") + #install sources install(FILES fuelcellproblem.hh fuelcellspatialparams.hh test_2pnc_fv.cc test_2pnc_fv.input +test_cc2pnc_diffusion.cc +maxwellstefandiffusion.hh +maxwellstefandiffusionspatialparams.hh DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/test/implicit/2pnc) +set(CMAKE_BUILD_TYPE Release) diff --git a/test/porousmediumflow/2pnc/implicit/test_2pnc_diffusion.input b/test/porousmediumflow/2pnc/implicit/test_2pnc_diffusion.input new file mode 100644 index 0000000000000000000000000000000000000000..b658cedc1385c9db7beeee5d4cb8e7e06510140a --- /dev/null +++ b/test/porousmediumflow/2pnc/implicit/test_2pnc_diffusion.input @@ -0,0 +1,11 @@ +[TimeLoop] +DtInitial = 250 # [s] +TEnd = 1e8 # [s] + +[Grid] +UpperRight = 60 40 +Cells = 50 5 + +[Problem] +Name = 2pnc_diffusion +EnableGravity = false diff --git a/test/porousmediumflow/2pnc/implicit/test_cc2pnc_diffusion.cc b/test/porousmediumflow/2pnc/implicit/test_cc2pnc_diffusion.cc new file mode 100644 index 0000000000000000000000000000000000000000..c039c680287c658e8009484ca46509f808e7359c --- /dev/null +++ b/test/porousmediumflow/2pnc/implicit/test_cc2pnc_diffusion.cc @@ -0,0 +1,243 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program 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 2 of the License, or * + * (at your option) any later version. * + * * + * This program 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 this program. If not, see . * + *****************************************************************************/ +/*! + * \file + * + * \brief Test for the 2pnc cc model used for water management in PEM fuel cells. + */ +#include + +#include +#include + +#include +#include +#include +#include +#include + +#include "2pncdiffusion.hh" + +#include +#include +#include +#include +#include + +#include +#include +#include + +#include +#include + +#include + +#include + +/*! + * \brief Provides an interface for customizing error messages associated with + * reading in parameters. + * + * \param progName The name of the program, that was tried to be started. + * \param errorMsg The error message that was issued by the start function. + * Comprises the thing that went wrong and a general help message. + */ +void usage(const char *progName, const std::string &errorMsg) +{ + if (errorMsg.size() > 0) { + std::string errorMessageOut = "\nUsage: "; + errorMessageOut += progName; + errorMessageOut += " [options]\n"; + errorMessageOut += errorMsg; + errorMessageOut += "\n\nThe list of mandatory options for this program is:\n" + "\t-ParameterFile Parameter file (Input file) \n"; + + std::cout << errorMessageOut + << "\n"; + } +} + +int main(int argc, char** argv) try +{ + using namespace Dumux; + + // define the type tag for this problem + using TypeTag = TTAG(TwoPNCDiffusionCCProblem); + + // initialize MPI, finalize is done automatically on exit + const auto& mpiHelper = Dune::MPIHelper::instance(argc, argv); + + // print dumux start message + if (mpiHelper.rank() == 0) + DumuxMessage::print(/*firstCall=*/true); + + // parse command line arguments and input file + Parameters::init(argc, argv, usage); + + // try to create a grid (from the given grid file or the input file) + using GridCreator = typename GET_PROP_TYPE(TypeTag, GridCreator); + GridCreator::makeGrid(); + GridCreator::loadBalance(); + + //////////////////////////////////////////////////////////// + // run instationary non-linear problem on this grid + //////////////////////////////////////////////////////////// + + // we compute on the leaf grid view + const auto& leafGridView = GridCreator::grid().leafGridView(); + + // create the finite volume grid geometry + using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry); + auto fvGridGeometry = std::make_shared(leafGridView); + fvGridGeometry->update(); + + // the problem (initial and boundary conditions) + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + auto problem = std::make_shared(fvGridGeometry); + + // the solution vector + using SolutionVector = typename GET_PROP_TYPE(TypeTag, SolutionVector); + SolutionVector x(fvGridGeometry->numDofs()); + problem->applyInitialSolution(x); + auto xOld = x; + + // the grid variables + using GridVariables = typename GET_PROP_TYPE(TypeTag, GridVariables); + auto gridVariables = std::make_shared(problem, fvGridGeometry); + gridVariables->init(x, xOld); + + // get some time loop parameters + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + const auto tEnd = getParam("TimeLoop.TEnd"); + const auto maxDivisions = getParam("TimeLoop.MaxTimeStepDivisions"); + const auto maxDt = getParam("TimeLoop.MaxTimeStepSize"); + auto dt = getParam("TimeLoop.DtInitial"); + + // check if we are about to restart a previously interrupted simulation + Scalar restartTime = 0; + if (Parameters::getTree().hasKey("Restart") || Parameters::getTree().hasKey("TimeLoop.Restart")) + restartTime = getParam("TimeLoop.Restart"); + + // intialize the vtk output module + using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields); + VtkOutputModule vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name()); + VtkOutputFields::init(vtkWriter); //! Add model specific output fields + vtkWriter.write(0.0); + + // instantiate time loop + auto timeLoop = std::make_shared>(restartTime, dt, tEnd); + timeLoop->setMaxTimeStepSize(maxDt); + + // the assembler with time loop for instationary problem + using Assembler = FVAssembler; + auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop); + + // the linear solver + using LinearSolver = AMGBackend; + auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + + // the non-linear solver + using NewtonController = PriVarSwitchNewtonController; + using NewtonMethod = NewtonMethod; + auto newtonController = std::make_shared(leafGridView.comm(), timeLoop); + NewtonMethod nonLinearSolver(newtonController, assembler, linearSolver); + + // time loop + timeLoop->start(); do + { + // set previous solution for storage evaluations + assembler->setPreviousSolution(xOld); + + // try solving the non-linear system + for (int i = 0; i < maxDivisions; ++i) + { + // linearize & solve + auto converged = nonLinearSolver.solve(x); + + if (converged) + break; + + if (!converged && i == maxDivisions-1) + DUNE_THROW(Dune::MathError, + "Newton solver didn't converge after " + << maxDivisions + << " time-step divisions. dt=" + << timeLoop->timeStepSize() + << ".\nThe solutions of the current and the previous time steps " + << "have been saved to restart files."); + } + + // make the new solution the old solution + xOld = x; + gridVariables->advanceTimeStep(); + + // advance to the time loop to the next step + timeLoop->advanceTimeStep(); + + // write vtk output + vtkWriter.write(timeLoop->time()); + + // report statistics of this time step + timeLoop->reportTimeStep(); + + // set new dt as suggested by newton controller + timeLoop->setTimeStepSize(newtonController->suggestTimeStepSize(timeLoop->timeStepSize())); + + } while (!timeLoop->finished()); + + timeLoop->finalize(leafGridView.comm()); + + //////////////////////////////////////////////////////////// + // finalize, print dumux message to say goodbye + //////////////////////////////////////////////////////////// + + // print dumux end message + if (mpiHelper.rank() == 0) + { + Parameters::print(); + DumuxMessage::print(/*firstCall=*/false); + } + + return 0; +} // end main +catch (Dumux::ParameterException &e) +{ + std::cerr << std::endl << e << " ---> Abort!" << std::endl; + return 1; +} +catch (Dune::DGFException & e) +{ + std::cerr << "DGF exception thrown (" << e << + "). Most likely, the DGF file name is wrong " + "or the DGF file is corrupted, " + "e.g. missing hash at end of file or wrong number (dimensions) of entries." + << " ---> Abort!" << std::endl; + return 2; +} +catch (Dune::Exception &e) +{ + std::cerr << "Dune reported error: " << e << " ---> Abort!" << std::endl; + return 3; +} +catch (...) +{ + std::cerr << "Unknown exception thrown! ---> Abort!" << std::endl; + return 4; +} diff --git a/test/porousmediumflow/tracer/CMakeLists.txt b/test/porousmediumflow/tracer/CMakeLists.txt index 7770e5721c70a9cfe7886bf13faf30360902c875..213b2b806b7107612a60ce5a10fdda093cf7dc0c 100644 --- a/test/porousmediumflow/tracer/CMakeLists.txt +++ b/test/porousmediumflow/tracer/CMakeLists.txt @@ -1,2 +1,3 @@ add_subdirectory("constvel") add_subdirectory("1ptracer") +add_subdirectory("multicomp") diff --git a/test/porousmediumflow/tracer/multicomp/CMakeLists.txt b/test/porousmediumflow/tracer/multicomp/CMakeLists.txt new file mode 100644 index 0000000000000000000000000000000000000000..a7b2e68e70ea0db68461119deff645ba97036dec --- /dev/null +++ b/test/porousmediumflow/tracer/multicomp/CMakeLists.txt @@ -0,0 +1,25 @@ +add_input_file_links() + +# tracer tests +dune_add_test(NAME test_maxwellstefan_tpfa + SOURCES test_tracer_maxwellstefan.cc + COMPILE_DEFINITIONS TYPETAG=MaxwellStefanTestCCProblem + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/cctracermaxwellstefan-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_ccmaxwellstefan-00026.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_maxwellstefan_tpfa test_tracer_maxwellstefan.input -Problem.Name test_ccmaxwellstefan") + +dune_add_test(NAME test_maxwellstefan_box + SOURCES test_tracer_maxwellstefan.cc + COMPILE_DEFINITIONS TYPETAG=MaxwellStefanTestBoxProblem + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/boxtracermaxwellstefan-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_boxmaxwellstefan-00026.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_maxwellstefan_box test_tracer_maxwellstefan.input -Problem.Name test_boxmaxwellstefan") +#install sources +install(FILES +maxwellstefantestproblem.hh +maxwellstefantestspatialparams.hh +DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/test/porousmediumflow/tracer) diff --git a/test/porousmediumflow/tracer/multicomp/maxwellstefantestproblem.hh b/test/porousmediumflow/tracer/multicomp/maxwellstefantestproblem.hh new file mode 100644 index 0000000000000000000000000000000000000000..7be6fc9431991acf4d8e737a532fd2c6f0f569e4 --- /dev/null +++ b/test/porousmediumflow/tracer/multicomp/maxwellstefantestproblem.hh @@ -0,0 +1,400 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program 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 2 of the License, or * + * (at your option) any later version. * + * * + * This program 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 this program. If not, see . * + *****************************************************************************/ +/** + * \file + * \ingroup TracerTest + * \brief Definition of a problem, for the MaxwellStefan problem: + * A rotating velocity field mixes a MaxwellStefan band in a porous groundwater reservoir. + */ +#ifndef DUMUX_MAXWELL_STEFAN_TEST_PROBLEM_HH +#define DUMUX_MAXWELL_STEFAN_TEST_PROBLEM_HH + +#include +#include + +#include +#include + +#include "maxwellstefantestspatialparams.hh" +#include + +#include +#include + +namespace Dumux +{ +template +class MaxwellStefanTestProblem; + +namespace Properties +{ +NEW_TYPE_TAG(MaxwellStefanTestProblem, INHERITS_FROM(Tracer)); +NEW_TYPE_TAG(MaxwellStefanTestCCProblem, INHERITS_FROM(CCTpfaModel, MaxwellStefanTestProblem)); +NEW_TYPE_TAG(MaxwellStefanTestBoxProblem, INHERITS_FROM(BoxModel, MaxwellStefanTestProblem)); + +// Set the grid type +SET_TYPE_PROP(MaxwellStefanTestProblem, Grid, Dune::YaspGrid<2>); + +// Set the problem property +SET_TYPE_PROP(MaxwellStefanTestProblem, Problem, MaxwellStefanTestProblem); + +// Set the spatial parameters +SET_TYPE_PROP(MaxwellStefanTestProblem, SpatialParams, MaxwellStefanTestSpatialParams); + +// Define whether mole(true) or mass (false) fractions are used +SET_BOOL_PROP(MaxwellStefanTestProblem, UseMoles, true); + +//! Here we set FicksLaw or MaxwellStefansLaw +SET_TYPE_PROP(MaxwellStefanTestProblem, MolecularDiffusionType, MaxwellStefansLaw); + +//! A simple fluid system with one MaxwellStefan component +template +class H2N2CO2FluidSystem: public FluidSystems::BaseFluidSystem> + +{ + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Element = typename GridView::template Codim<0>::Entity; + using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); + +public: + static constexpr bool isTracerFluidSystem() + { return true; } + //! The number of components + static constexpr int numComponents = 3; + + static constexpr int H2Idx = 0;//first major component + static constexpr int N2Idx = 1;//second major component + static constexpr int CO2Idx = 2;//secondary component + + //! Human readable component name (index compIdx) (for vtk output) + static std::string componentName(int compIdx) + { + switch (compIdx) + { + case H2Idx: return "H2"; + case N2Idx: return "N2"; + case CO2Idx:return "CO2"; + } + DUNE_THROW(Dune::InvalidStateException, "Invalid component index " << compIdx); + } + + //! Human readable phase name (index phaseIdx) (for velocity vtk output) + static std::string phaseName(int phaseIdx = 0) + { return "Gas"; } + + //! Molar mass in kg/mol of the component with index compIdx + static Scalar molarMass(unsigned int compIdx) + { + switch (compIdx) + { + case H2Idx: return 0.002; + case N2Idx: return 0.028; + case CO2Idx:return 0.044; + } + DUNE_THROW(Dune::InvalidStateException, "Invalid component index " << compIdx); + } + + //! binary diffusion coefficient + //! (might depend on spatial parameters like pressure / temperature) + static Scalar binaryDiffusionCoefficient(unsigned int compIdx, + const Problem& problem, + const Element& element, + const SubControlVolume& scv) + { + if (compIdx == H2Idx) + return 0; + if (compIdx == N2Idx) + return 83.3e-6; + if (compIdx == CO2Idx) + return 68.0e-6; + DUNE_THROW(Dune::InvalidStateException, + "Binary diffusion coefficient of component " + << compIdx <<" is undefined!\n"); + } + + //! binary diffusion coefficient + //! (might depend on spatial parameters like pressure / temperature) + static Scalar binaryDiffusionCoefficient(unsigned int compIIdx, + unsigned int compJIdx, + const Problem& problem, + const Element& element, + const SubControlVolume& scv) + { + if (compIIdx > compJIdx) + { + using std::swap; + swap(compIIdx, compJIdx); + } + + if (compIIdx == H2Idx && compJIdx == N2Idx) + return 83.3e-6; + if (compIIdx == H2Idx && compJIdx == CO2Idx) + return 68.0e-6; + if (compIIdx == N2Idx && compJIdx == CO2Idx) + return 16.8e-6; + DUNE_THROW(Dune::InvalidStateException, + "Binary diffusion coefficient of components " + << compIIdx << " and " << compJIdx << " is undefined!\n"); + } +}; + +SET_TYPE_PROP(MaxwellStefanTestProblem, FluidSystem, H2N2CO2FluidSystem); + +} // end namespace Properties + + +/*! + * \ingroup TracerTest + * \brief Definition of a problem, for the MaxwellStefan problem * + * This problem uses the \ref MaxwellStefanModel model. + * + * To run the simulation execute the following line in shell: + * ./test_boxmaxwellstefan -ParameterFile ./test_boxmaxwellstefan.input or + * ./test_ccmaxwellstefan -ParameterFile ./test_ccMaxwellstefan.input + */ +template +class MaxwellStefanTestProblem : public PorousMediumFlowProblem +{ + using ParentType = PorousMediumFlowProblem; + + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Indices = typename GET_PROP_TYPE(TypeTag, Indices); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); + using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); + using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem); + using SpatialParams = typename GET_PROP_TYPE(TypeTag, SpatialParams); + using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry); + using SolutionVector = typename GET_PROP_TYPE(TypeTag, SolutionVector); + using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables); + using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); + + //! property that defines whether mole or mass fractions are used + static const bool useMoles = GET_PROP_VALUE(TypeTag, UseMoles); + + static const int dimWorld = GridView::dimensionworld; + using GlobalPosition = Dune::FieldVector; + +public: + MaxwellStefanTestProblem(std::shared_ptr fvGridGeometry) + : ParentType(fvGridGeometry) + { + name_ = getParam("Problem.Name"); + + // stating in the console whether mole or mass fractions are used + if(useMoles) + std::cout<<"problem uses mole fractions" << '\n'; + else + std::cout<<"problem uses mass fractions" << '\n'; + + plotOutput_ = false; + } + + /*! + * \name Problem parameters + */ + // \{ + + /*! + * \brief The problem name. + * This is used as a prefix for files generated by the simulation. + */ + const std::string& name() const + { return name_; } + + //! Called after every time step + void postTimeStep(const SolutionVector& curSol, Scalar time) + { + if (plotOutput_) + { + Scalar x_co2_left = 0.0; + Scalar x_n2_left = 0.0; + Scalar x_co2_right = 0.0; + Scalar x_n2_right = 0.0; + Scalar x_h2_left = 0.0; + Scalar x_h2_right = 0.0; + Scalar i = 0.0; + Scalar j = 0.0; + if (!(time < 0.0)) + { + for (const auto& element : elements(this->fvGridGeometry().gridView())) + { + auto fvGeometry = localView(this->fvGridGeometry()); + fvGeometry.bindElement(element); + + ElementSolutionVector elemSol(element, curSol, this->fvGridGeometry()); + for (auto&& scv : scvs(fvGeometry)) + { + const auto& globalPos = scv.dofPosition(); + VolumeVariables volVars; + volVars.update(elemSol, *this, element, scv); + + if (globalPos[0] < 0.5) + { + x_co2_left += volVars.moleFraction(0,2); + + x_n2_left += volVars.moleFraction(0,1); + x_h2_left += volVars.moleFraction(0,0); + i +=1; + } + else + { + x_co2_right += volVars.moleFraction(0,2); + x_n2_right += volVars.moleFraction(0,1); + x_h2_right += volVars.moleFraction(0,0); + j +=1; + } + + } + } + x_co2_left /= i; + x_n2_left /= i; + x_h2_left /= i; + x_co2_right /= j; + x_n2_right /= j; + x_h2_right /= j; + + //do a gnuplot + x_.push_back(time); // in seconds + y_.push_back(x_n2_left); + y2_.push_back(x_n2_right); + y3_.push_back(x_co2_left); + y4_.push_back(x_co2_right); + y5_.push_back(x_h2_left); + y6_.push_back(x_h2_right); + + gnuplot_.resetPlot(); + gnuplot_.setXRange(0, std::min(time, 72000.0)); + gnuplot_.setYRange(0.4, 0.6); + gnuplot_.setXlabel("time [s]"); + gnuplot_.setYlabel("mole fraction mol/mol"); + gnuplot_.addDataSetToPlot(x_, y_, "N2_left"); + gnuplot_.addDataSetToPlot(x_, y2_, "N2_right"); + gnuplot_.plot("mole_fraction_N2"); + + gnuplot2_.resetPlot(); + gnuplot2_.setXRange(0, std::min(time, 72000.0)); + gnuplot2_.setYRange(0.0, 0.6); + gnuplot2_.setXlabel("time [s]"); + gnuplot2_.setYlabel("mole fraction mol/mol"); + gnuplot2_.addDataSetToPlot(x_, y3_, "C02_left"); + gnuplot2_.addDataSetToPlot(x_, y4_, "C02_right"); + gnuplot2_.plot("mole_fraction_C02"); + + gnuplot3_.resetPlot(); + gnuplot3_.setXRange(0, std::min(time, 72000.0)); + gnuplot3_.setYRange(0.0, 0.6); + gnuplot3_.setXlabel("time [s]"); + gnuplot3_.setYlabel("mole fraction mol/mol"); + gnuplot3_.addDataSetToPlot(x_, y5_, "H2_left"); + gnuplot3_.addDataSetToPlot(x_, y6_, "H2_right"); + gnuplot3_.plot("mole_fraction_H2"); + } + } + } + + // \} + + /*! + * \name Boundary conditions + */ + // \{ + + /*! + * \brief Specifies which kind of boundary condition should be + * used for which equation on a given boundary segment. + * + * \param globalPos The position for which the bc type should be evaluated + */ + BoundaryTypes boundaryTypesAtPos(const GlobalPosition &globalPos) const + { + BoundaryTypes values; + values.setAllNeumann(); + return values; + } + + /*! + * \brief Evaluate the boundary conditions for a Neumann + * boundary segment. + * + * \param globalPos The position for which the bc type should be evaluated + * The units must be according to either using mole or mass fractions. (mole/(m^2*s) or kg/(m^2*s)) + */ + PrimaryVariables neumannAtPos(const GlobalPosition& globalPos) const + { return PrimaryVariables(0.0); } + + // \} + + /*! + * \name Volume terms + */ + // \{ + + /*! + * \brief Evaluate the initial value for a control volume. + * + * \param globalPos The position for which the initial condition should be evaluated + * + * For this method, the \a values parameter stores primary + * variables. + */ + PrimaryVariables initialAtPos(const GlobalPosition &globalPos) const + { + PrimaryVariables initialValues(0.0); + if (globalPos[0] < 0.5) + { + initialValues[FluidSystem::H2Idx] = 0.0; + initialValues[FluidSystem::N2Idx] = 0.50086; + initialValues[FluidSystem::CO2Idx] = 0.49914; + } + else + { + initialValues[FluidSystem::H2Idx] = 0.50121; + initialValues[FluidSystem::N2Idx] = 0.49879; + initialValues[FluidSystem::CO2Idx] = 0.0; + } + return initialValues; + } + + // \} + +private: + static constexpr Scalar eps_ = 1e-6; + std::string name_; + + Dumux::GnuplotInterface gnuplot_; + Dumux::GnuplotInterface gnuplot2_; + Dumux::GnuplotInterface gnuplot3_; + + std::vector x_; + std::vector y_; + std::vector y2_; + std::vector y3_; + std::vector y4_; + std::vector y5_; + std::vector y6_; + + bool plotOutput_; +}; + +} //end namespace Dumux + +#endif diff --git a/test/porousmediumflow/tracer/multicomp/maxwellstefantestspatialparams.hh b/test/porousmediumflow/tracer/multicomp/maxwellstefantestspatialparams.hh new file mode 100644 index 0000000000000000000000000000000000000000..0eadc6d948ffc41a967ab0308a834d763174ef30 --- /dev/null +++ b/test/porousmediumflow/tracer/multicomp/maxwellstefantestspatialparams.hh @@ -0,0 +1,111 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program 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 2 of the License, or * + * (at your option) any later version. * + * * + * This program 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 this program. If not, see . * + *****************************************************************************/ +/*! + * \file + *\ingroup TracerTest + * \brief Definition of the spatial parameters for the MaxwellStefan problem + */ +#ifndef DUMUX_MAXWELL_STEFAN_TEST_SPATIAL_PARAMS_HH +#define DUMUX_MAXWELL_STEFAN_TEST_SPATIAL_PARAMS_HH + +#include + +namespace Dumux +{ + +/*! + * \ingroup TracerTest + * \brief Definition of the spatial parameters for the MaxwellStefan problem + */ +template +class MaxwellStefanTestSpatialParams : public FVSpatialParamsOneP +{ + using ParentType = FVSpatialParamsOneP; + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Element = typename GridView::template Codim<0>::Entity; + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); + using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); + using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); + using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); + + static const int dimWorld = GridView::dimensionworld; + using GlobalPosition = typename Dune::FieldVector; + +public: + + MaxwellStefanTestSpatialParams(const Problem& problem) + : ParentType(problem) {} + + /*! + * \brief Define the porosity \f$\mathrm{[-]}\f$. + * + * \param globalPos The global position + */ + Scalar porosityAtPos(const GlobalPosition& globalPos) const + { return 0.4; } + + /*! + * \brief Define the dispersivity. + * + * \param element The finite element + * \param scv The sub-control volume + * \param elemSol The solution for all dofs of the element + */ + Scalar dispersivity(const Element &element, + const SubControlVolume& scv, + const ElementSolutionVector& elemSol) const + { return 0; } + + //! Fluid properties that are spatial params in the tracer model + //! They can possible vary with space but are usually constants + + //! fluid density + Scalar fluidDensity(const Element &element, + const SubControlVolume& scv) const + { return 1; } + + //! fluid molar mass + Scalar fluidMolarMass(const Element &element, + const SubControlVolume& scv) const + { return 0.02896; /*air*/} + + //! velocity field + GlobalPosition velocity(const SubControlVolumeFace& scvf) const + { + GlobalPosition vel(0.0); + + return vel; + } + + //! velocity field + Scalar volumeFlux(const Element &element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolumeFace& scvf) const + { + return 0; + } +}; + +} // end namespace Dumux + +#endif diff --git a/test/porousmediumflow/tracer/multicomp/test_tracer_maxwellstefan.cc b/test/porousmediumflow/tracer/multicomp/test_tracer_maxwellstefan.cc new file mode 100644 index 0000000000000000000000000000000000000000..3d90cd96979c4e6b73fb33028ffe6e677c2e379d --- /dev/null +++ b/test/porousmediumflow/tracer/multicomp/test_tracer_maxwellstefan.cc @@ -0,0 +1,253 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program 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 2 of the License, or * + * (at your option) any later version. * + * * + * This program 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 this program. If not, see . * + *****************************************************************************/ +/*! + * \file + * + * \brief test for the two-phase porousmedium flow model + */ +#include + +#include +#include + +#include +#include +#include +#include +#include + +#include "maxwellstefantestproblem.hh" + +#include +#include +#include +#include +#include + +#include +#include +#include + +#include +#include + +#include + +#include + +/*! + * \brief Provides an interface for customizing error messages associated with + * reading in parameters. + * + * \param progName The name of the program, that was tried to be started. + * \param errorMsg The error message that was issued by the start function. + * Comprises the thing that went wrong and a general help message. + */ +void usage(const char *progName, const std::string &errorMsg) +{ + if (errorMsg.size() > 0) { + std::string errorMessageOut = "\nUsage: "; + errorMessageOut += progName; + errorMessageOut += " [options]\n"; + errorMessageOut += errorMsg; + errorMessageOut += "\n\nThe list of mandatory arguments for this program is:\n" + "\t-TimeManager.TEnd End of the simulation [s] \n" + "\t-TimeManager.DtInitial Initial timestep size [s] \n" + "\t-Grid.LowerLeft Lower left corner coordinates\n" + "\t-Grid.UpperRight Upper right corner coordinates\n" + "\t-Grid.Cells Number of cells in respective coordinate directions\n" + "\t definition in DGF format\n" + "\t-SpatialParams.LensLowerLeft coordinates of the lower left corner of the lens [m] \n" + "\t-SpatialParams.LensUpperRight coordinates of the upper right corner of the lens [m] \n" + "\t-SpatialParams.Permeability Permeability of the domain [m^2] \n" + "\t-SpatialParams.PermeabilityLens Permeability of the lens [m^2] \n"; + + std::cout << errorMessageOut + << "\n"; + } +} + +int main(int argc, char** argv) try +{ + using namespace Dumux; + + // define the type tag for this problem + using TypeTag = TTAG(TYPETAG); + + // initialize MPI, finalize is done automatically on exit + const auto& mpiHelper = Dune::MPIHelper::instance(argc, argv); + + // print dumux start message + if (mpiHelper.rank() == 0) + DumuxMessage::print(/*firstCall=*/true); + + // parse command line arguments and input file + Parameters::init(argc, argv, usage); + + // try to create a grid (from the given grid file or the input file) + using GridCreator = typename GET_PROP_TYPE(TypeTag, GridCreator); + GridCreator::makeGrid(); + GridCreator::loadBalance(); + + //////////////////////////////////////////////////////////// + // run instationary non-linear problem on this grid + //////////////////////////////////////////////////////////// + + // we compute on the leaf grid view + const auto& leafGridView = GridCreator::grid().leafGridView(); + + // create the finite volume grid geometry + using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry); + auto fvGridGeometry = std::make_shared(leafGridView); + fvGridGeometry->update(); + + // the problem (initial and boundary conditions) + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + auto problem = std::make_shared(fvGridGeometry); + + // the solution vector + using SolutionVector = typename GET_PROP_TYPE(TypeTag, SolutionVector); + SolutionVector x(fvGridGeometry->numDofs()); + problem->applyInitialSolution(x); + auto xOld = x; + + // the grid variables + using GridVariables = typename GET_PROP_TYPE(TypeTag, GridVariables); + auto gridVariables = std::make_shared(problem, fvGridGeometry); + gridVariables->init(x, xOld); + + // get some time loop parameters + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + const auto tEnd = getParam("TimeLoop.TEnd"); + const auto maxDivisions = getParam("TimeLoop.MaxTimeStepDivisions"); + const auto maxDt = getParam("TimeLoop.MaxTimeStepSize"); + auto dt = getParam("TimeLoop.DtInitial"); + + // check if we are about to restart a previously interrupted simulation + Scalar restartTime = 0; + if (Parameters::getTree().hasKey("Restart") || Parameters::getTree().hasKey("TimeLoop.Restart")) + restartTime = getParam("TimeLoop.Restart"); + + // intialize the vtk output module + using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields); + VtkOutputModule vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name()); + VtkOutputFields::init(vtkWriter); //! Add model specific output fields + vtkWriter.write(0.0); + + // instantiate time loop + auto timeLoop = std::make_shared>(restartTime, dt, tEnd); + timeLoop->setMaxTimeStepSize(maxDt); + + // the assembler with time loop for instationary problem + using Assembler = FVAssembler; + auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop); + + // the linear solver + using LinearSolver = AMGBackend; + auto linearSolver = std::make_shared(leafGridView, fvGridGeometry->dofMapper()); + + // the non-linear solver + using NewtonController = Dumux::NewtonController; + using NewtonMethod = Dumux::NewtonMethod; + auto newtonController = std::make_shared(leafGridView.comm(), timeLoop); + NewtonMethod nonLinearSolver(newtonController, assembler, linearSolver); + + // time loop + timeLoop->start(); do + { + // set previous solution for storage evaluations + assembler->setPreviousSolution(xOld); + + // try solving the non-linear system + for (int i = 0; i < maxDivisions; ++i) + { + // linearize & solve + auto converged = nonLinearSolver.solve(x); + + if (converged) + break; + + if (!converged && i == maxDivisions-1) + DUNE_THROW(Dune::MathError, + "Newton solver didn't converge after " + << maxDivisions + << " time-step divisions. dt=" + << timeLoop->timeStepSize() + << ".\nThe solutions of the current and the previous time steps " + << "have been saved to restart files."); + } + + // make the new solution the old solution + xOld = x; + gridVariables->advanceTimeStep(); + problem->postTimeStep(x, timeLoop->time() + timeLoop->timeStepSize()); + + // advance to the time loop to the next step + timeLoop->advanceTimeStep(); + + // write vtk output + vtkWriter.write(timeLoop->time()); + + // report statistics of this time step + timeLoop->reportTimeStep(); + + // set new dt as suggested by newton controller + timeLoop->setTimeStepSize(newtonController->suggestTimeStepSize(timeLoop->timeStepSize())); + + } while (!timeLoop->finished()); + + timeLoop->finalize(leafGridView.comm()); + + //////////////////////////////////////////////////////////// + // finalize, print dumux message to say goodbye + //////////////////////////////////////////////////////////// + + // print dumux end message + if (mpiHelper.rank() == 0) + { + Parameters::print(); + DumuxMessage::print(/*firstCall=*/false); + } + + return 0; +} // end main +catch (Dumux::ParameterException &e) +{ + std::cerr << std::endl << e << " ---> Abort!" << std::endl; + return 1; +} +catch (Dune::DGFException & e) +{ + std::cerr << "DGF exception thrown (" << e << + "). Most likely, the DGF file name is wrong " + "or the DGF file is corrupted, " + "e.g. missing hash at end of file or wrong number (dimensions) of entries." + << " ---> Abort!" << std::endl; + return 2; +} +catch (Dune::Exception &e) +{ + std::cerr << "Dune reported error: " << e << " ---> Abort!" << std::endl; + return 3; +} +catch (...) +{ + std::cerr << "Unknown exception thrown! ---> Abort!" << std::endl; + return 4; +} diff --git a/test/porousmediumflow/tracer/multicomp/test_tracer_maxwellstefan.input b/test/porousmediumflow/tracer/multicomp/test_tracer_maxwellstefan.input new file mode 100644 index 0000000000000000000000000000000000000000..02d9c39c88876d5f06ddd2016cc9d26abeb56d89 --- /dev/null +++ b/test/porousmediumflow/tracer/multicomp/test_tracer_maxwellstefan.input @@ -0,0 +1,16 @@ +[TimeLoop] +DtInitial = 1 # [s] +TEnd = 70000 # [s] + +[Grid] +UpperRight = 1 1 +Cells = 30 30 + +[Problem] +Name = maxwellstefan # name passed to the output routines + +[Vtk] +AddVelocity = true + +[Newton] +MaxRelativeShift = 1e-12 diff --git a/test/references/2pncdiffusioncc-reference.vtu b/test/references/2pncdiffusioncc-reference.vtu new file mode 100644 index 0000000000000000000000000000000000000000..f2dedfdfb095669cbede1d49498e468b76b8972e --- /dev/null +++ b/test/references/2pncdiffusioncc-reference.vtu @@ -0,0 +1,638 @@ + + + + + + + 0.97476 0.981798 0.99437 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 0.974621 0.98151 0.994002 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 0.97462 0.981509 0.994001 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 0.974621 0.98151 0.994002 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 0.97476 0.981798 0.99437 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 + + + 0.0252401 0.0182019 0.00563007 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0.0253794 0.0184899 0.0059984 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0.0253798 0.018491 0.00599902 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0.0253794 0.0184899 0.0059984 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0.0252401 0.0182019 0.00563007 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 + + + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 + + + 100102 100101 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100102 100101 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100102 100101 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100102 100101 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100102 100101 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + 100100 100100 100100 100100 100100 100100 100100 100100 100100 100100 + + + 102.027 101.453 100.444 100 100 100 100 100 100 100 100 100 + 100 100 100 100 100 100 100 100 100 100 100 100 + 100 100 100 100 100 100 100 100 100 100 100 100 + 100 100 100 100 100 100 100 100 100 100 100 100 + 100 100 102.039 101.476 100.473 100 100 100 100 100 100 100 + 100 100 100 100 100 100 100 100 100 100 100 100 + 100 100 100 100 100 100 100 100 100 100 100 100 + 100 100 100 100 100 100 100 100 100 100 100 100 + 100 100 100 100 102.039 101.476 100.473 100 100 100 100 100 + 100 100 100 100 100 100 100 100 100 100 100 100 + 100 100 100 100 100 100 100 100 100 100 100 100 + 100 100 100 100 100 100 100 100 100 100 100 100 + 100 100 100 100 100 100 102.039 101.476 100.473 100 100 100 + 100 100 100 100 100 100 100 100 100 100 100 100 + 100 100 100 100 100 100 100 100 100 100 100 100 + 100 100 100 100 100 100 100 100 100 100 100 100 + 100 100 100 100 100 100 100 100 102.027 101.453 100.444 100 + 100 100 100 100 100 100 100 100 100 100 100 100 + 100 100 100 100 100 100 100 100 100 100 100 100 + 100 100 100 100 100 100 100 100 100 100 100 100 + 100 100 100 100 100 100 100 100 100 100 + + + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 998.191 + + + 1.14085 1.14085 1.14084 1.13891 1.13875 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.14085 1.14085 1.14084 1.13892 1.13875 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.14085 1.14085 1.14084 1.13892 1.13875 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.14085 1.14085 1.14084 1.13892 1.13875 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.14085 1.14085 1.14084 1.13891 + 1.13875 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 1.13874 + + + 885.675 915.695 971.287 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 885.088 914.451 969.621 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 885.086 914.446 969.619 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 885.088 914.451 969.621 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 885.675 915.695 971.287 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 997.019 + + + 2.44403 0.921728 0.0275488 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 2.48445 0.965959 0.0333075 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 2.48457 0.966138 0.0333178 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 2.48445 0.965959 0.0333075 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 2.44403 0.921728 0.0275488 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 + + + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 0.2 + + + 0.999988 0.999988 0.999988 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.999988 0.999988 0.999988 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.999988 0.999988 0.999988 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.999988 0.999988 0.999988 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.999988 0.999988 0.999988 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 0.99999 + + + 1.22313e-05 1.22313e-05 1.22311e-05 1.01504e-05 1.00048e-05 1.00001e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1.22313e-05 1.22313e-05 1.22311e-05 1.01626e-05 1.00051e-05 1.00001e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1.22313e-05 1.22313e-05 1.22311e-05 1.01621e-05 1.0005e-05 1.00001e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1.22313e-05 1.22313e-05 1.22311e-05 1.01626e-05 1.00051e-05 1.00001e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1.22313e-05 1.22313e-05 1.22311e-05 1.01504e-05 + 1.00048e-05 1.00001e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 1e-05 + + + 0.0234767 0.0234768 0.0234771 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234767 0.0234768 0.0234771 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234767 0.0234768 0.0234771 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234767 0.0234768 0.0234771 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234767 0.0234768 0.0234771 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 0.0234772 + + + 0.976523 0.976523 0.976523 0.810398 0.798777 0.798405 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.976523 0.976523 0.976523 0.811379 0.798799 0.798406 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.976523 0.976523 0.976523 0.811337 0.798795 0.798406 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.976523 0.976523 0.976523 0.811379 0.798799 0.798406 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.976523 0.976523 0.976523 0.810398 + 0.798777 0.798405 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 0.798394 + + + 55407.3 55407.3 55407.3 55407.4 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.3 55407.3 55407.3 55407.4 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.3 55407.3 55407.3 55407.4 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.3 55407.3 55407.3 55407.4 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.3 55407.3 55407.3 55407.4 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 55407.5 + + + 0.677714 0.67771 0.677703 0.562411 0.554346 0.554088 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.677714 0.67771 0.677703 0.563092 0.554361 0.554088 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.677714 0.67771 0.677703 0.563062 0.554359 0.554088 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.677714 0.67771 0.677703 0.563092 0.554361 0.554088 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.677714 0.67771 0.677703 0.562411 + 0.554346 0.554088 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 0.55408 + + + 3 3 3 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 3 3 3 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 3 3 3 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 3 3 3 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 3 3 3 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 + + + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 + + + + + 0 0 0 1.2 0 0 0 8 0 1.2 8 0 + 2.4 0 0 2.4 8 0 3.6 0 0 3.6 8 0 + 4.8 0 0 4.8 8 0 6 0 0 6 8 0 + 7.2 0 0 7.2 8 0 8.4 0 0 8.4 8 0 + 9.6 0 0 9.6 8 0 10.8 0 0 10.8 8 0 + 12 0 0 12 8 0 13.2 0 0 13.2 8 0 + 14.4 0 0 14.4 8 0 15.6 0 0 15.6 8 0 + 16.8 0 0 16.8 8 0 18 0 0 18 8 0 + 19.2 0 0 19.2 8 0 20.4 0 0 20.4 8 0 + 21.6 0 0 21.6 8 0 22.8 0 0 22.8 8 0 + 24 0 0 24 8 0 25.2 0 0 25.2 8 0 + 26.4 0 0 26.4 8 0 27.6 0 0 27.6 8 0 + 28.8 0 0 28.8 8 0 30 0 0 30 8 0 + 31.2 0 0 31.2 8 0 32.4 0 0 32.4 8 0 + 33.6 0 0 33.6 8 0 34.8 0 0 34.8 8 0 + 36 0 0 36 8 0 37.2 0 0 37.2 8 0 + 38.4 0 0 38.4 8 0 39.6 0 0 39.6 8 0 + 40.8 0 0 40.8 8 0 42 0 0 42 8 0 + 43.2 0 0 43.2 8 0 44.4 0 0 44.4 8 0 + 45.6 0 0 45.6 8 0 46.8 0 0 46.8 8 0 + 48 0 0 48 8 0 49.2 0 0 49.2 8 0 + 50.4 0 0 50.4 8 0 51.6 0 0 51.6 8 0 + 52.8 0 0 52.8 8 0 54 0 0 54 8 0 + 55.2 0 0 55.2 8 0 56.4 0 0 56.4 8 0 + 57.6 0 0 57.6 8 0 58.8 0 0 58.8 8 0 + 60 0 0 60 8 0 0 16 0 1.2 16 0 + 2.4 16 0 3.6 16 0 4.8 16 0 6 16 0 + 7.2 16 0 8.4 16 0 9.6 16 0 10.8 16 0 + 12 16 0 13.2 16 0 14.4 16 0 15.6 16 0 + 16.8 16 0 18 16 0 19.2 16 0 20.4 16 0 + 21.6 16 0 22.8 16 0 24 16 0 25.2 16 0 + 26.4 16 0 27.6 16 0 28.8 16 0 30 16 0 + 31.2 16 0 32.4 16 0 33.6 16 0 34.8 16 0 + 36 16 0 37.2 16 0 38.4 16 0 39.6 16 0 + 40.8 16 0 42 16 0 43.2 16 0 44.4 16 0 + 45.6 16 0 46.8 16 0 48 16 0 49.2 16 0 + 50.4 16 0 51.6 16 0 52.8 16 0 54 16 0 + 55.2 16 0 56.4 16 0 57.6 16 0 58.8 16 0 + 60 16 0 0 24 0 1.2 24 0 2.4 24 0 + 3.6 24 0 4.8 24 0 6 24 0 7.2 24 0 + 8.4 24 0 9.6 24 0 10.8 24 0 12 24 0 + 13.2 24 0 14.4 24 0 15.6 24 0 16.8 24 0 + 18 24 0 19.2 24 0 20.4 24 0 21.6 24 0 + 22.8 24 0 24 24 0 25.2 24 0 26.4 24 0 + 27.6 24 0 28.8 24 0 30 24 0 31.2 24 0 + 32.4 24 0 33.6 24 0 34.8 24 0 36 24 0 + 37.2 24 0 38.4 24 0 39.6 24 0 40.8 24 0 + 42 24 0 43.2 24 0 44.4 24 0 45.6 24 0 + 46.8 24 0 48 24 0 49.2 24 0 50.4 24 0 + 51.6 24 0 52.8 24 0 54 24 0 55.2 24 0 + 56.4 24 0 57.6 24 0 58.8 24 0 60 24 0 + 0 32 0 1.2 32 0 2.4 32 0 3.6 32 0 + 4.8 32 0 6 32 0 7.2 32 0 8.4 32 0 + 9.6 32 0 10.8 32 0 12 32 0 13.2 32 0 + 14.4 32 0 15.6 32 0 16.8 32 0 18 32 0 + 19.2 32 0 20.4 32 0 21.6 32 0 22.8 32 0 + 24 32 0 25.2 32 0 26.4 32 0 27.6 32 0 + 28.8 32 0 30 32 0 31.2 32 0 32.4 32 0 + 33.6 32 0 34.8 32 0 36 32 0 37.2 32 0 + 38.4 32 0 39.6 32 0 40.8 32 0 42 32 0 + 43.2 32 0 44.4 32 0 45.6 32 0 46.8 32 0 + 48 32 0 49.2 32 0 50.4 32 0 51.6 32 0 + 52.8 32 0 54 32 0 55.2 32 0 56.4 32 0 + 57.6 32 0 58.8 32 0 60 32 0 0 40 0 + 1.2 40 0 2.4 40 0 3.6 40 0 4.8 40 0 + 6 40 0 7.2 40 0 8.4 40 0 9.6 40 0 + 10.8 40 0 12 40 0 13.2 40 0 14.4 40 0 + 15.6 40 0 16.8 40 0 18 40 0 19.2 40 0 + 20.4 40 0 21.6 40 0 22.8 40 0 24 40 0 + 25.2 40 0 26.4 40 0 27.6 40 0 28.8 40 0 + 30 40 0 31.2 40 0 32.4 40 0 33.6 40 0 + 34.8 40 0 36 40 0 37.2 40 0 38.4 40 0 + 39.6 40 0 40.8 40 0 42 40 0 43.2 40 0 + 44.4 40 0 45.6 40 0 46.8 40 0 48 40 0 + 49.2 40 0 50.4 40 0 51.6 40 0 52.8 40 0 + 54 40 0 55.2 40 0 56.4 40 0 57.6 40 0 + 58.8 40 0 60 40 0 + + + + + 0 1 3 2 1 4 5 3 4 6 7 5 + 6 8 9 7 8 10 11 9 10 12 13 11 + 12 14 15 13 14 16 17 15 16 18 19 17 + 18 20 21 19 20 22 23 21 22 24 25 23 + 24 26 27 25 26 28 29 27 28 30 31 29 + 30 32 33 31 32 34 35 33 34 36 37 35 + 36 38 39 37 38 40 41 39 40 42 43 41 + 42 44 45 43 44 46 47 45 46 48 49 47 + 48 50 51 49 50 52 53 51 52 54 55 53 + 54 56 57 55 56 58 59 57 58 60 61 59 + 60 62 63 61 62 64 65 63 64 66 67 65 + 66 68 69 67 68 70 71 69 70 72 73 71 + 72 74 75 73 74 76 77 75 76 78 79 77 + 78 80 81 79 80 82 83 81 82 84 85 83 + 84 86 87 85 86 88 89 87 88 90 91 89 + 90 92 93 91 92 94 95 93 94 96 97 95 + 96 98 99 97 98 100 101 99 2 3 103 102 + 3 5 104 103 5 7 105 104 7 9 106 105 + 9 11 107 106 11 13 108 107 13 15 109 108 + 15 17 110 109 17 19 111 110 19 21 112 111 + 21 23 113 112 23 25 114 113 25 27 115 114 + 27 29 116 115 29 31 117 116 31 33 118 117 + 33 35 119 118 35 37 120 119 37 39 121 120 + 39 41 122 121 41 43 123 122 43 45 124 123 + 45 47 125 124 47 49 126 125 49 51 127 126 + 51 53 128 127 53 55 129 128 55 57 130 129 + 57 59 131 130 59 61 132 131 61 63 133 132 + 63 65 134 133 65 67 135 134 67 69 136 135 + 69 71 137 136 71 73 138 137 73 75 139 138 + 75 77 140 139 77 79 141 140 79 81 142 141 + 81 83 143 142 83 85 144 143 85 87 145 144 + 87 89 146 145 89 91 147 146 91 93 148 147 + 93 95 149 148 95 97 150 149 97 99 151 150 + 99 101 152 151 102 103 154 153 103 104 155 154 + 104 105 156 155 105 106 157 156 106 107 158 157 + 107 108 159 158 108 109 160 159 109 110 161 160 + 110 111 162 161 111 112 163 162 112 113 164 163 + 113 114 165 164 114 115 166 165 115 116 167 166 + 116 117 168 167 117 118 169 168 118 119 170 169 + 119 120 171 170 120 121 172 171 121 122 173 172 + 122 123 174 173 123 124 175 174 124 125 176 175 + 125 126 177 176 126 127 178 177 127 128 179 178 + 128 129 180 179 129 130 181 180 130 131 182 181 + 131 132 183 182 132 133 184 183 133 134 185 184 + 134 135 186 185 135 136 187 186 136 137 188 187 + 137 138 189 188 138 139 190 189 139 140 191 190 + 140 141 192 191 141 142 193 192 142 143 194 193 + 143 144 195 194 144 145 196 195 145 146 197 196 + 146 147 198 197 147 148 199 198 148 149 200 199 + 149 150 201 200 150 151 202 201 151 152 203 202 + 153 154 205 204 154 155 206 205 155 156 207 206 + 156 157 208 207 157 158 209 208 158 159 210 209 + 159 160 211 210 160 161 212 211 161 162 213 212 + 162 163 214 213 163 164 215 214 164 165 216 215 + 165 166 217 216 166 167 218 217 167 168 219 218 + 168 169 220 219 169 170 221 220 170 171 222 221 + 171 172 223 222 172 173 224 223 173 174 225 224 + 174 175 226 225 175 176 227 226 176 177 228 227 + 177 178 229 228 178 179 230 229 179 180 231 230 + 180 181 232 231 181 182 233 232 182 183 234 233 + 183 184 235 234 184 185 236 235 185 186 237 236 + 186 187 238 237 187 188 239 238 188 189 240 239 + 189 190 241 240 190 191 242 241 191 192 243 242 + 192 193 244 243 193 194 245 244 194 195 246 245 + 195 196 247 246 196 197 248 247 197 198 249 248 + 198 199 250 249 199 200 251 250 200 201 252 251 + 201 202 253 252 202 203 254 253 204 205 256 255 + 205 206 257 256 206 207 258 257 207 208 259 258 + 208 209 260 259 209 210 261 260 210 211 262 261 + 211 212 263 262 212 213 264 263 213 214 265 264 + 214 215 266 265 215 216 267 266 216 217 268 267 + 217 218 269 268 218 219 270 269 219 220 271 270 + 220 221 272 271 221 222 273 272 222 223 274 273 + 223 224 275 274 224 225 276 275 225 226 277 276 + 226 227 278 277 227 228 279 278 228 229 280 279 + 229 230 281 280 230 231 282 281 231 232 283 282 + 232 233 284 283 233 234 285 284 234 235 286 285 + 235 236 287 286 236 237 288 287 237 238 289 288 + 238 239 290 289 239 240 291 290 240 241 292 291 + 241 242 293 292 242 243 294 293 243 244 295 294 + 244 245 296 295 245 246 297 296 246 247 298 297 + 247 248 299 298 248 249 300 299 249 250 301 300 + 250 251 302 301 251 252 303 302 252 253 304 303 + 253 254 305 304 + + + 4 8 12 16 20 24 28 32 36 40 44 48 + 52 56 60 64 68 72 76 80 84 88 92 96 + 100 104 108 112 116 120 124 128 132 136 140 144 + 148 152 156 160 164 168 172 176 180 184 188 192 + 196 200 204 208 212 216 220 224 228 232 236 240 + 244 248 252 256 260 264 268 272 276 280 284 288 + 292 296 300 304 308 312 316 320 324 328 332 336 + 340 344 348 352 356 360 364 368 372 376 380 384 + 388 392 396 400 404 408 412 416 420 424 428 432 + 436 440 444 448 452 456 460 464 468 472 476 480 + 484 488 492 496 500 504 508 512 516 520 524 528 + 532 536 540 544 548 552 556 560 564 568 572 576 + 580 584 588 592 596 600 604 608 612 616 620 624 + 628 632 636 640 644 648 652 656 660 664 668 672 + 676 680 684 688 692 696 700 704 708 712 716 720 + 724 728 732 736 740 744 748 752 756 760 764 768 + 772 776 780 784 788 792 796 800 804 808 812 816 + 820 824 828 832 836 840 844 848 852 856 860 864 + 868 872 876 880 884 888 892 896 900 904 908 912 + 916 920 924 928 932 936 940 944 948 952 956 960 + 964 968 972 976 980 984 988 992 996 1000 + + + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 + + + + + diff --git a/test/references/boxtracermaxwellstefan-reference.vtu b/test/references/boxtracermaxwellstefan-reference.vtu new file mode 100644 index 0000000000000000000000000000000000000000..1eb09454435ef6b5e24d79ba11b86a8e4079b97d --- /dev/null +++ b/test/references/boxtracermaxwellstefan-reference.vtu @@ -0,0 +1,1615 @@ + + + + + + + 0.258921 0.258921 0.258921 0.258921 0.258922 0.258922 0.258923 0.258923 0.258924 0.258924 0.258926 0.258926 + 0.258928 0.258928 0.25893 0.25893 0.258933 0.258933 0.258936 0.258936 0.25894 0.25894 0.258943 0.258943 + 0.258947 0.258947 0.258951 0.258951 0.258955 0.258955 0.258958 0.258958 0.258962 0.258962 0.258966 0.258966 + 0.25897 0.25897 0.258974 0.258974 0.258977 0.258977 0.258981 0.258981 0.258984 0.258984 0.258987 0.258987 + 0.258989 0.258989 0.258991 0.258991 0.258993 0.258993 0.258994 0.258994 0.258995 0.258995 0.258996 0.258996 + 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 + 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 + 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 + 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 + 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 + 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 + 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 + 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 + 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 + 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 + 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 + 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 + 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 + 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 0.25894 + 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 0.258984 + 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 + 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 + 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 + 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 + 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 + 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 + 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 + 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 + 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 + 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 + 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 + 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 + 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 + 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 + 0.258926 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 + 0.258966 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 + 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 + 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 + 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 + 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 + 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 + 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 + 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 + 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 + 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 + 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 + 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 + 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 + 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 + 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 0.25894 + 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 0.258984 + 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 + 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 + 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 + 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 + 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 + 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 + 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 + 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 + 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 + 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 + 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 + 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 + 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 + 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 + 0.258926 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 + 0.258966 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 + 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 + 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 + 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 + 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 + 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 + 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 + 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 + 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 + 0.258921 0.258922 0.258923 0.258924 0.258926 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 + 0.258951 0.258955 0.258958 0.258962 0.258966 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 + 0.258991 0.258993 0.258994 0.258995 0.258996 0.258996 0.258921 0.258921 0.258922 0.258923 0.258924 0.258926 + 0.258928 0.25893 0.258933 0.258936 0.25894 0.258943 0.258947 0.258951 0.258955 0.258958 0.258962 0.258966 + 0.25897 0.258974 0.258977 0.258981 0.258984 0.258987 0.258989 0.258991 0.258993 0.258994 0.258995 0.258996 + 0.258996 + + + 0.0178813 0.0178813 0.0178813 0.0178813 0.0178813 0.0178813 0.0178814 0.0178814 0.0178815 0.0178815 0.0178816 0.0178816 + 0.0178818 0.0178818 0.0178819 0.0178819 0.0178821 0.0178821 0.0178823 0.0178823 0.0178826 0.0178826 0.0178828 0.0178828 + 0.0178831 0.0178831 0.0178833 0.0178833 0.0178836 0.0178836 0.0178839 0.0178839 0.0178841 0.0178841 0.0178844 0.0178844 + 0.0178847 0.0178847 0.0178849 0.0178849 0.0178852 0.0178852 0.0178854 0.0178854 0.0178856 0.0178856 0.0178858 0.0178858 + 0.017886 0.017886 0.0178861 0.0178861 0.0178863 0.0178863 0.0178864 0.0178864 0.0178864 0.0178864 0.0178865 0.0178865 + 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 + 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 + 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 + 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 + 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 + 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 + 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 + 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 + 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 + 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 + 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 + 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 + 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 + 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 + 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 + 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 + 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 + 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 + 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 + 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 + 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 + 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 + 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 + 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 + 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 + 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 + 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 + 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 + 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 + 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 + 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 + 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 + 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 + 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 + 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 + 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 + 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 + 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 + 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 + 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 + 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 + 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 + 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 + 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 + 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 + 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 + 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 + 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 + 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 + 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 + 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 + 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 + 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 + 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 + 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 + 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 + 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 + 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 + 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 + 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 + 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 + 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 + 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 + 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 + 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 + 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 + 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 + 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 + 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 + 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 + 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 + 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 + 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 0.0178865 0.0178813 0.0178813 0.0178813 0.0178814 0.0178815 0.0178816 + 0.0178818 0.0178819 0.0178821 0.0178823 0.0178826 0.0178828 0.0178831 0.0178833 0.0178836 0.0178839 0.0178841 0.0178844 + 0.0178847 0.0178849 0.0178852 0.0178854 0.0178856 0.0178858 0.017886 0.0178861 0.0178863 0.0178864 0.0178864 0.0178865 + 0.0178865 + + + 0.498132 0.498141 0.498132 0.498141 0.498168 0.498168 0.498213 0.498213 0.498275 0.498275 0.498354 0.498354 + 0.498448 0.498448 0.498558 0.498558 0.49868 0.49868 0.498815 0.498815 0.498961 0.498961 0.499115 0.499115 + 0.499277 0.499277 0.499445 0.499445 0.499616 0.499616 0.49979 0.49979 0.499963 0.499963 0.500135 0.500135 + 0.500303 0.500303 0.500465 0.500465 0.50062 0.50062 0.500766 0.500766 0.500901 0.500901 0.501024 0.501024 + 0.501133 0.501133 0.501228 0.501228 0.501307 0.501307 0.501369 0.501369 0.501414 0.501414 0.501441 0.501441 + 0.50145 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 + 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 + 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 + 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 + 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 + 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 + 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 + 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 + 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 + 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 + 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 + 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 + 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 + 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 0.498961 + 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 0.500901 + 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 0.498213 + 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 + 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 + 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 + 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 + 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 + 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 + 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 + 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 + 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 + 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 + 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 + 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 + 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 + 0.498354 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 + 0.500135 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 + 0.501441 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 + 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 + 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 + 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 + 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 + 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 + 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 + 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 + 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 + 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 + 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 + 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 + 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 + 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 0.498961 + 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 0.500901 + 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 0.498213 + 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 + 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 + 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 + 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 + 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 + 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 + 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 + 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 + 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 + 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 + 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 + 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 + 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 + 0.498354 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 + 0.500135 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 + 0.501441 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 + 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 + 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 + 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 + 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 + 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 + 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 + 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 + 0.498141 0.498168 0.498213 0.498275 0.498354 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 + 0.499445 0.499616 0.49979 0.499963 0.500135 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 + 0.501228 0.501307 0.501369 0.501414 0.501441 0.50145 0.498132 0.498141 0.498168 0.498213 0.498275 0.498354 + 0.498448 0.498558 0.49868 0.498815 0.498961 0.499115 0.499277 0.499445 0.499616 0.49979 0.499963 0.500135 + 0.500303 0.500465 0.50062 0.500766 0.500901 0.501024 0.501133 0.501228 0.501307 0.501369 0.501414 0.501441 + 0.50145 + + + 0.481619 0.481628 0.481619 0.481628 0.481654 0.481654 0.481698 0.481698 0.481758 0.481758 0.481834 0.481834 + 0.481925 0.481925 0.482031 0.482031 0.482149 0.482149 0.48228 0.48228 0.48242 0.48242 0.48257 0.48257 + 0.482727 0.482727 0.482889 0.482889 0.483055 0.483055 0.483222 0.483222 0.48339 0.48339 0.483556 0.483556 + 0.483718 0.483718 0.483875 0.483875 0.484025 0.484025 0.484166 0.484166 0.484296 0.484296 0.484415 0.484415 + 0.484521 0.484521 0.484612 0.484612 0.484689 0.484689 0.484749 0.484749 0.484793 0.484793 0.484819 0.484819 + 0.484828 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 + 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 + 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 + 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 + 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 + 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 + 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 + 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 + 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 + 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 + 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 + 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 + 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 + 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 0.48242 + 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 0.484296 + 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 0.481698 + 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 + 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 + 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 + 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 + 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 + 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 + 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 + 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 + 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 + 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 + 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 + 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 + 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 + 0.481834 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 + 0.483556 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 + 0.484819 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 + 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 + 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 + 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 + 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 + 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 + 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 + 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 + 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 + 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 + 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 + 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 + 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 + 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 0.48242 + 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 0.484296 + 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 0.481698 + 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 + 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 + 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 + 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 + 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 + 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 + 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 + 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 + 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 + 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 + 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 + 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 + 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 + 0.481834 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 + 0.483556 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 + 0.484819 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 + 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 + 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 + 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 + 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 + 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 + 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 + 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 + 0.481628 0.481654 0.481698 0.481758 0.481834 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 + 0.482889 0.483055 0.483222 0.48339 0.483556 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 + 0.484612 0.484689 0.484749 0.484793 0.484819 0.484828 0.481619 0.481628 0.481654 0.481698 0.481758 0.481834 + 0.481925 0.482031 0.482149 0.48228 0.48242 0.48257 0.482727 0.482889 0.483055 0.483222 0.48339 0.483556 + 0.483718 0.483875 0.484025 0.484166 0.484296 0.484415 0.484521 0.484612 0.484689 0.484749 0.484793 0.484819 + 0.484828 + + + 0.242947 0.242938 0.242947 0.242938 0.24291 0.24291 0.242864 0.242864 0.242801 0.242801 0.24272 0.24272 + 0.242624 0.242624 0.242512 0.242512 0.242387 0.242387 0.242249 0.242249 0.2421 0.2421 0.241942 0.241942 + 0.241776 0.241776 0.241604 0.241604 0.241429 0.241429 0.241252 0.241252 0.241074 0.241074 0.240899 0.240899 + 0.240727 0.240727 0.240561 0.240561 0.240403 0.240403 0.240254 0.240254 0.240116 0.240116 0.23999 0.23999 + 0.239878 0.239878 0.239781 0.239781 0.2397 0.2397 0.239637 0.239637 0.239591 0.239591 0.239563 0.239563 + 0.239553 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 + 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 + 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 + 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 + 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 + 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 + 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 + 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 + 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 + 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 + 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 + 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 + 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 + 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 0.2421 + 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 0.240116 + 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 0.242864 + 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 + 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 + 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 + 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 + 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 + 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 + 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 + 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 + 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 + 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 + 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 + 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 + 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 + 0.24272 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 + 0.240899 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 + 0.239563 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 + 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 + 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 + 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 + 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 + 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 + 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 + 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 + 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 + 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 + 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 + 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 + 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 + 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 0.2421 + 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 0.240116 + 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 0.242864 + 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 + 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 + 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 + 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 + 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 + 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 + 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 + 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 + 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 + 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 + 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 + 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 + 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 + 0.24272 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 + 0.240899 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 + 0.239563 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 + 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 + 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 + 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 + 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 + 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 + 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 + 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 + 0.242938 0.24291 0.242864 0.242801 0.24272 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 + 0.241604 0.241429 0.241252 0.241074 0.240899 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 + 0.239781 0.2397 0.239637 0.239591 0.239563 0.239553 0.242947 0.242938 0.24291 0.242864 0.242801 0.24272 + 0.242624 0.242512 0.242387 0.242249 0.2421 0.241942 0.241776 0.241604 0.241429 0.241252 0.241074 0.240899 + 0.240727 0.240561 0.240403 0.240254 0.240116 0.23999 0.239878 0.239781 0.2397 0.239637 0.239591 0.239563 + 0.239553 + + + 0.369119 0.369105 0.369119 0.369105 0.369062 0.369062 0.368993 0.368993 0.368896 0.368896 0.368774 0.368774 + 0.368627 0.368627 0.368457 0.368457 0.368267 0.368267 0.368057 0.368057 0.367831 0.367831 0.367591 0.367591 + 0.367339 0.367339 0.367079 0.367079 0.366812 0.366812 0.366543 0.366543 0.366273 0.366273 0.366007 0.366007 + 0.365746 0.365746 0.365494 0.365494 0.365253 0.365253 0.365027 0.365027 0.364817 0.364817 0.364626 0.364626 + 0.364455 0.364455 0.364308 0.364308 0.364186 0.364186 0.364089 0.364089 0.364019 0.364019 0.363977 0.363977 + 0.363962 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 + 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 + 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 + 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 + 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 + 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 + 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 + 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 + 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 + 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 + 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 + 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 + 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 + 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 0.367831 + 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 0.364817 + 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 0.368993 + 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 + 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 + 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 + 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 + 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 + 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 + 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 + 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 + 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 + 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 + 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 + 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 + 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 + 0.368774 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 + 0.366007 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 + 0.363977 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 + 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 + 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 + 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 + 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 + 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 + 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 + 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 + 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 + 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 + 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 + 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 + 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 + 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 0.367831 + 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 0.364817 + 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 0.368993 + 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 + 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 + 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 + 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 + 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 + 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 + 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 + 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 + 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 + 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 + 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 + 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 + 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 + 0.368774 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 + 0.366007 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 + 0.363977 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 + 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 + 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 + 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 + 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 + 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 + 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 + 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 + 0.369105 0.369062 0.368993 0.368896 0.368774 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 + 0.367079 0.366812 0.366543 0.366273 0.366007 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 + 0.364308 0.364186 0.364089 0.364019 0.363977 0.363962 0.369119 0.369105 0.369062 0.368993 0.368896 0.368774 + 0.368627 0.368457 0.368267 0.368057 0.367831 0.367591 0.367339 0.367079 0.366812 0.366543 0.366273 0.366007 + 0.365746 0.365494 0.365253 0.365027 0.364817 0.364626 0.364455 0.364308 0.364186 0.364089 0.364019 0.363977 + 0.363962 + + + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 + + + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 + + + + + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + + + + + 0 0 0 0.0333333 0 0 0 0.0333333 0 0.0333333 0.0333333 0 + 0.0666667 0 0 0.0666667 0.0333333 0 0.1 0 0 0.1 0.0333333 0 + 0.133333 0 0 0.133333 0.0333333 0 0.166667 0 0 0.166667 0.0333333 0 + 0.2 0 0 0.2 0.0333333 0 0.233333 0 0 0.233333 0.0333333 0 + 0.266667 0 0 0.266667 0.0333333 0 0.3 0 0 0.3 0.0333333 0 + 0.333333 0 0 0.333333 0.0333333 0 0.366667 0 0 0.366667 0.0333333 0 + 0.4 0 0 0.4 0.0333333 0 0.433333 0 0 0.433333 0.0333333 0 + 0.466667 0 0 0.466667 0.0333333 0 0.5 0 0 0.5 0.0333333 0 + 0.533333 0 0 0.533333 0.0333333 0 0.566667 0 0 0.566667 0.0333333 0 + 0.6 0 0 0.6 0.0333333 0 0.633333 0 0 0.633333 0.0333333 0 + 0.666667 0 0 0.666667 0.0333333 0 0.7 0 0 0.7 0.0333333 0 + 0.733333 0 0 0.733333 0.0333333 0 0.766667 0 0 0.766667 0.0333333 0 + 0.8 0 0 0.8 0.0333333 0 0.833333 0 0 0.833333 0.0333333 0 + 0.866667 0 0 0.866667 0.0333333 0 0.9 0 0 0.9 0.0333333 0 + 0.933333 0 0 0.933333 0.0333333 0 0.966667 0 0 0.966667 0.0333333 0 + 1 0 0 1 0.0333333 0 0 0.0666667 0 0.0333333 0.0666667 0 + 0.0666667 0.0666667 0 0.1 0.0666667 0 0.133333 0.0666667 0 0.166667 0.0666667 0 + 0.2 0.0666667 0 0.233333 0.0666667 0 0.266667 0.0666667 0 0.3 0.0666667 0 + 0.333333 0.0666667 0 0.366667 0.0666667 0 0.4 0.0666667 0 0.433333 0.0666667 0 + 0.466667 0.0666667 0 0.5 0.0666667 0 0.533333 0.0666667 0 0.566667 0.0666667 0 + 0.6 0.0666667 0 0.633333 0.0666667 0 0.666667 0.0666667 0 0.7 0.0666667 0 + 0.733333 0.0666667 0 0.766667 0.0666667 0 0.8 0.0666667 0 0.833333 0.0666667 0 + 0.866667 0.0666667 0 0.9 0.0666667 0 0.933333 0.0666667 0 0.966667 0.0666667 0 + 1 0.0666667 0 0 0.1 0 0.0333333 0.1 0 0.0666667 0.1 0 + 0.1 0.1 0 0.133333 0.1 0 0.166667 0.1 0 0.2 0.1 0 + 0.233333 0.1 0 0.266667 0.1 0 0.3 0.1 0 0.333333 0.1 0 + 0.366667 0.1 0 0.4 0.1 0 0.433333 0.1 0 0.466667 0.1 0 + 0.5 0.1 0 0.533333 0.1 0 0.566667 0.1 0 0.6 0.1 0 + 0.633333 0.1 0 0.666667 0.1 0 0.7 0.1 0 0.733333 0.1 0 + 0.766667 0.1 0 0.8 0.1 0 0.833333 0.1 0 0.866667 0.1 0 + 0.9 0.1 0 0.933333 0.1 0 0.966667 0.1 0 1 0.1 0 + 0 0.133333 0 0.0333333 0.133333 0 0.0666667 0.133333 0 0.1 0.133333 0 + 0.133333 0.133333 0 0.166667 0.133333 0 0.2 0.133333 0 0.233333 0.133333 0 + 0.266667 0.133333 0 0.3 0.133333 0 0.333333 0.133333 0 0.366667 0.133333 0 + 0.4 0.133333 0 0.433333 0.133333 0 0.466667 0.133333 0 0.5 0.133333 0 + 0.533333 0.133333 0 0.566667 0.133333 0 0.6 0.133333 0 0.633333 0.133333 0 + 0.666667 0.133333 0 0.7 0.133333 0 0.733333 0.133333 0 0.766667 0.133333 0 + 0.8 0.133333 0 0.833333 0.133333 0 0.866667 0.133333 0 0.9 0.133333 0 + 0.933333 0.133333 0 0.966667 0.133333 0 1 0.133333 0 0 0.166667 0 + 0.0333333 0.166667 0 0.0666667 0.166667 0 0.1 0.166667 0 0.133333 0.166667 0 + 0.166667 0.166667 0 0.2 0.166667 0 0.233333 0.166667 0 0.266667 0.166667 0 + 0.3 0.166667 0 0.333333 0.166667 0 0.366667 0.166667 0 0.4 0.166667 0 + 0.433333 0.166667 0 0.466667 0.166667 0 0.5 0.166667 0 0.533333 0.166667 0 + 0.566667 0.166667 0 0.6 0.166667 0 0.633333 0.166667 0 0.666667 0.166667 0 + 0.7 0.166667 0 0.733333 0.166667 0 0.766667 0.166667 0 0.8 0.166667 0 + 0.833333 0.166667 0 0.866667 0.166667 0 0.9 0.166667 0 0.933333 0.166667 0 + 0.966667 0.166667 0 1 0.166667 0 0 0.2 0 0.0333333 0.2 0 + 0.0666667 0.2 0 0.1 0.2 0 0.133333 0.2 0 0.166667 0.2 0 + 0.2 0.2 0 0.233333 0.2 0 0.266667 0.2 0 0.3 0.2 0 + 0.333333 0.2 0 0.366667 0.2 0 0.4 0.2 0 0.433333 0.2 0 + 0.466667 0.2 0 0.5 0.2 0 0.533333 0.2 0 0.566667 0.2 0 + 0.6 0.2 0 0.633333 0.2 0 0.666667 0.2 0 0.7 0.2 0 + 0.733333 0.2 0 0.766667 0.2 0 0.8 0.2 0 0.833333 0.2 0 + 0.866667 0.2 0 0.9 0.2 0 0.933333 0.2 0 0.966667 0.2 0 + 1 0.2 0 0 0.233333 0 0.0333333 0.233333 0 0.0666667 0.233333 0 + 0.1 0.233333 0 0.133333 0.233333 0 0.166667 0.233333 0 0.2 0.233333 0 + 0.233333 0.233333 0 0.266667 0.233333 0 0.3 0.233333 0 0.333333 0.233333 0 + 0.366667 0.233333 0 0.4 0.233333 0 0.433333 0.233333 0 0.466667 0.233333 0 + 0.5 0.233333 0 0.533333 0.233333 0 0.566667 0.233333 0 0.6 0.233333 0 + 0.633333 0.233333 0 0.666667 0.233333 0 0.7 0.233333 0 0.733333 0.233333 0 + 0.766667 0.233333 0 0.8 0.233333 0 0.833333 0.233333 0 0.866667 0.233333 0 + 0.9 0.233333 0 0.933333 0.233333 0 0.966667 0.233333 0 1 0.233333 0 + 0 0.266667 0 0.0333333 0.266667 0 0.0666667 0.266667 0 0.1 0.266667 0 + 0.133333 0.266667 0 0.166667 0.266667 0 0.2 0.266667 0 0.233333 0.266667 0 + 0.266667 0.266667 0 0.3 0.266667 0 0.333333 0.266667 0 0.366667 0.266667 0 + 0.4 0.266667 0 0.433333 0.266667 0 0.466667 0.266667 0 0.5 0.266667 0 + 0.533333 0.266667 0 0.566667 0.266667 0 0.6 0.266667 0 0.633333 0.266667 0 + 0.666667 0.266667 0 0.7 0.266667 0 0.733333 0.266667 0 0.766667 0.266667 0 + 0.8 0.266667 0 0.833333 0.266667 0 0.866667 0.266667 0 0.9 0.266667 0 + 0.933333 0.266667 0 0.966667 0.266667 0 1 0.266667 0 0 0.3 0 + 0.0333333 0.3 0 0.0666667 0.3 0 0.1 0.3 0 0.133333 0.3 0 + 0.166667 0.3 0 0.2 0.3 0 0.233333 0.3 0 0.266667 0.3 0 + 0.3 0.3 0 0.333333 0.3 0 0.366667 0.3 0 0.4 0.3 0 + 0.433333 0.3 0 0.466667 0.3 0 0.5 0.3 0 0.533333 0.3 0 + 0.566667 0.3 0 0.6 0.3 0 0.633333 0.3 0 0.666667 0.3 0 + 0.7 0.3 0 0.733333 0.3 0 0.766667 0.3 0 0.8 0.3 0 + 0.833333 0.3 0 0.866667 0.3 0 0.9 0.3 0 0.933333 0.3 0 + 0.966667 0.3 0 1 0.3 0 0 0.333333 0 0.0333333 0.333333 0 + 0.0666667 0.333333 0 0.1 0.333333 0 0.133333 0.333333 0 0.166667 0.333333 0 + 0.2 0.333333 0 0.233333 0.333333 0 0.266667 0.333333 0 0.3 0.333333 0 + 0.333333 0.333333 0 0.366667 0.333333 0 0.4 0.333333 0 0.433333 0.333333 0 + 0.466667 0.333333 0 0.5 0.333333 0 0.533333 0.333333 0 0.566667 0.333333 0 + 0.6 0.333333 0 0.633333 0.333333 0 0.666667 0.333333 0 0.7 0.333333 0 + 0.733333 0.333333 0 0.766667 0.333333 0 0.8 0.333333 0 0.833333 0.333333 0 + 0.866667 0.333333 0 0.9 0.333333 0 0.933333 0.333333 0 0.966667 0.333333 0 + 1 0.333333 0 0 0.366667 0 0.0333333 0.366667 0 0.0666667 0.366667 0 + 0.1 0.366667 0 0.133333 0.366667 0 0.166667 0.366667 0 0.2 0.366667 0 + 0.233333 0.366667 0 0.266667 0.366667 0 0.3 0.366667 0 0.333333 0.366667 0 + 0.366667 0.366667 0 0.4 0.366667 0 0.433333 0.366667 0 0.466667 0.366667 0 + 0.5 0.366667 0 0.533333 0.366667 0 0.566667 0.366667 0 0.6 0.366667 0 + 0.633333 0.366667 0 0.666667 0.366667 0 0.7 0.366667 0 0.733333 0.366667 0 + 0.766667 0.366667 0 0.8 0.366667 0 0.833333 0.366667 0 0.866667 0.366667 0 + 0.9 0.366667 0 0.933333 0.366667 0 0.966667 0.366667 0 1 0.366667 0 + 0 0.4 0 0.0333333 0.4 0 0.0666667 0.4 0 0.1 0.4 0 + 0.133333 0.4 0 0.166667 0.4 0 0.2 0.4 0 0.233333 0.4 0 + 0.266667 0.4 0 0.3 0.4 0 0.333333 0.4 0 0.366667 0.4 0 + 0.4 0.4 0 0.433333 0.4 0 0.466667 0.4 0 0.5 0.4 0 + 0.533333 0.4 0 0.566667 0.4 0 0.6 0.4 0 0.633333 0.4 0 + 0.666667 0.4 0 0.7 0.4 0 0.733333 0.4 0 0.766667 0.4 0 + 0.8 0.4 0 0.833333 0.4 0 0.866667 0.4 0 0.9 0.4 0 + 0.933333 0.4 0 0.966667 0.4 0 1 0.4 0 0 0.433333 0 + 0.0333333 0.433333 0 0.0666667 0.433333 0 0.1 0.433333 0 0.133333 0.433333 0 + 0.166667 0.433333 0 0.2 0.433333 0 0.233333 0.433333 0 0.266667 0.433333 0 + 0.3 0.433333 0 0.333333 0.433333 0 0.366667 0.433333 0 0.4 0.433333 0 + 0.433333 0.433333 0 0.466667 0.433333 0 0.5 0.433333 0 0.533333 0.433333 0 + 0.566667 0.433333 0 0.6 0.433333 0 0.633333 0.433333 0 0.666667 0.433333 0 + 0.7 0.433333 0 0.733333 0.433333 0 0.766667 0.433333 0 0.8 0.433333 0 + 0.833333 0.433333 0 0.866667 0.433333 0 0.9 0.433333 0 0.933333 0.433333 0 + 0.966667 0.433333 0 1 0.433333 0 0 0.466667 0 0.0333333 0.466667 0 + 0.0666667 0.466667 0 0.1 0.466667 0 0.133333 0.466667 0 0.166667 0.466667 0 + 0.2 0.466667 0 0.233333 0.466667 0 0.266667 0.466667 0 0.3 0.466667 0 + 0.333333 0.466667 0 0.366667 0.466667 0 0.4 0.466667 0 0.433333 0.466667 0 + 0.466667 0.466667 0 0.5 0.466667 0 0.533333 0.466667 0 0.566667 0.466667 0 + 0.6 0.466667 0 0.633333 0.466667 0 0.666667 0.466667 0 0.7 0.466667 0 + 0.733333 0.466667 0 0.766667 0.466667 0 0.8 0.466667 0 0.833333 0.466667 0 + 0.866667 0.466667 0 0.9 0.466667 0 0.933333 0.466667 0 0.966667 0.466667 0 + 1 0.466667 0 0 0.5 0 0.0333333 0.5 0 0.0666667 0.5 0 + 0.1 0.5 0 0.133333 0.5 0 0.166667 0.5 0 0.2 0.5 0 + 0.233333 0.5 0 0.266667 0.5 0 0.3 0.5 0 0.333333 0.5 0 + 0.366667 0.5 0 0.4 0.5 0 0.433333 0.5 0 0.466667 0.5 0 + 0.5 0.5 0 0.533333 0.5 0 0.566667 0.5 0 0.6 0.5 0 + 0.633333 0.5 0 0.666667 0.5 0 0.7 0.5 0 0.733333 0.5 0 + 0.766667 0.5 0 0.8 0.5 0 0.833333 0.5 0 0.866667 0.5 0 + 0.9 0.5 0 0.933333 0.5 0 0.966667 0.5 0 1 0.5 0 + 0 0.533333 0 0.0333333 0.533333 0 0.0666667 0.533333 0 0.1 0.533333 0 + 0.133333 0.533333 0 0.166667 0.533333 0 0.2 0.533333 0 0.233333 0.533333 0 + 0.266667 0.533333 0 0.3 0.533333 0 0.333333 0.533333 0 0.366667 0.533333 0 + 0.4 0.533333 0 0.433333 0.533333 0 0.466667 0.533333 0 0.5 0.533333 0 + 0.533333 0.533333 0 0.566667 0.533333 0 0.6 0.533333 0 0.633333 0.533333 0 + 0.666667 0.533333 0 0.7 0.533333 0 0.733333 0.533333 0 0.766667 0.533333 0 + 0.8 0.533333 0 0.833333 0.533333 0 0.866667 0.533333 0 0.9 0.533333 0 + 0.933333 0.533333 0 0.966667 0.533333 0 1 0.533333 0 0 0.566667 0 + 0.0333333 0.566667 0 0.0666667 0.566667 0 0.1 0.566667 0 0.133333 0.566667 0 + 0.166667 0.566667 0 0.2 0.566667 0 0.233333 0.566667 0 0.266667 0.566667 0 + 0.3 0.566667 0 0.333333 0.566667 0 0.366667 0.566667 0 0.4 0.566667 0 + 0.433333 0.566667 0 0.466667 0.566667 0 0.5 0.566667 0 0.533333 0.566667 0 + 0.566667 0.566667 0 0.6 0.566667 0 0.633333 0.566667 0 0.666667 0.566667 0 + 0.7 0.566667 0 0.733333 0.566667 0 0.766667 0.566667 0 0.8 0.566667 0 + 0.833333 0.566667 0 0.866667 0.566667 0 0.9 0.566667 0 0.933333 0.566667 0 + 0.966667 0.566667 0 1 0.566667 0 0 0.6 0 0.0333333 0.6 0 + 0.0666667 0.6 0 0.1 0.6 0 0.133333 0.6 0 0.166667 0.6 0 + 0.2 0.6 0 0.233333 0.6 0 0.266667 0.6 0 0.3 0.6 0 + 0.333333 0.6 0 0.366667 0.6 0 0.4 0.6 0 0.433333 0.6 0 + 0.466667 0.6 0 0.5 0.6 0 0.533333 0.6 0 0.566667 0.6 0 + 0.6 0.6 0 0.633333 0.6 0 0.666667 0.6 0 0.7 0.6 0 + 0.733333 0.6 0 0.766667 0.6 0 0.8 0.6 0 0.833333 0.6 0 + 0.866667 0.6 0 0.9 0.6 0 0.933333 0.6 0 0.966667 0.6 0 + 1 0.6 0 0 0.633333 0 0.0333333 0.633333 0 0.0666667 0.633333 0 + 0.1 0.633333 0 0.133333 0.633333 0 0.166667 0.633333 0 0.2 0.633333 0 + 0.233333 0.633333 0 0.266667 0.633333 0 0.3 0.633333 0 0.333333 0.633333 0 + 0.366667 0.633333 0 0.4 0.633333 0 0.433333 0.633333 0 0.466667 0.633333 0 + 0.5 0.633333 0 0.533333 0.633333 0 0.566667 0.633333 0 0.6 0.633333 0 + 0.633333 0.633333 0 0.666667 0.633333 0 0.7 0.633333 0 0.733333 0.633333 0 + 0.766667 0.633333 0 0.8 0.633333 0 0.833333 0.633333 0 0.866667 0.633333 0 + 0.9 0.633333 0 0.933333 0.633333 0 0.966667 0.633333 0 1 0.633333 0 + 0 0.666667 0 0.0333333 0.666667 0 0.0666667 0.666667 0 0.1 0.666667 0 + 0.133333 0.666667 0 0.166667 0.666667 0 0.2 0.666667 0 0.233333 0.666667 0 + 0.266667 0.666667 0 0.3 0.666667 0 0.333333 0.666667 0 0.366667 0.666667 0 + 0.4 0.666667 0 0.433333 0.666667 0 0.466667 0.666667 0 0.5 0.666667 0 + 0.533333 0.666667 0 0.566667 0.666667 0 0.6 0.666667 0 0.633333 0.666667 0 + 0.666667 0.666667 0 0.7 0.666667 0 0.733333 0.666667 0 0.766667 0.666667 0 + 0.8 0.666667 0 0.833333 0.666667 0 0.866667 0.666667 0 0.9 0.666667 0 + 0.933333 0.666667 0 0.966667 0.666667 0 1 0.666667 0 0 0.7 0 + 0.0333333 0.7 0 0.0666667 0.7 0 0.1 0.7 0 0.133333 0.7 0 + 0.166667 0.7 0 0.2 0.7 0 0.233333 0.7 0 0.266667 0.7 0 + 0.3 0.7 0 0.333333 0.7 0 0.366667 0.7 0 0.4 0.7 0 + 0.433333 0.7 0 0.466667 0.7 0 0.5 0.7 0 0.533333 0.7 0 + 0.566667 0.7 0 0.6 0.7 0 0.633333 0.7 0 0.666667 0.7 0 + 0.7 0.7 0 0.733333 0.7 0 0.766667 0.7 0 0.8 0.7 0 + 0.833333 0.7 0 0.866667 0.7 0 0.9 0.7 0 0.933333 0.7 0 + 0.966667 0.7 0 1 0.7 0 0 0.733333 0 0.0333333 0.733333 0 + 0.0666667 0.733333 0 0.1 0.733333 0 0.133333 0.733333 0 0.166667 0.733333 0 + 0.2 0.733333 0 0.233333 0.733333 0 0.266667 0.733333 0 0.3 0.733333 0 + 0.333333 0.733333 0 0.366667 0.733333 0 0.4 0.733333 0 0.433333 0.733333 0 + 0.466667 0.733333 0 0.5 0.733333 0 0.533333 0.733333 0 0.566667 0.733333 0 + 0.6 0.733333 0 0.633333 0.733333 0 0.666667 0.733333 0 0.7 0.733333 0 + 0.733333 0.733333 0 0.766667 0.733333 0 0.8 0.733333 0 0.833333 0.733333 0 + 0.866667 0.733333 0 0.9 0.733333 0 0.933333 0.733333 0 0.966667 0.733333 0 + 1 0.733333 0 0 0.766667 0 0.0333333 0.766667 0 0.0666667 0.766667 0 + 0.1 0.766667 0 0.133333 0.766667 0 0.166667 0.766667 0 0.2 0.766667 0 + 0.233333 0.766667 0 0.266667 0.766667 0 0.3 0.766667 0 0.333333 0.766667 0 + 0.366667 0.766667 0 0.4 0.766667 0 0.433333 0.766667 0 0.466667 0.766667 0 + 0.5 0.766667 0 0.533333 0.766667 0 0.566667 0.766667 0 0.6 0.766667 0 + 0.633333 0.766667 0 0.666667 0.766667 0 0.7 0.766667 0 0.733333 0.766667 0 + 0.766667 0.766667 0 0.8 0.766667 0 0.833333 0.766667 0 0.866667 0.766667 0 + 0.9 0.766667 0 0.933333 0.766667 0 0.966667 0.766667 0 1 0.766667 0 + 0 0.8 0 0.0333333 0.8 0 0.0666667 0.8 0 0.1 0.8 0 + 0.133333 0.8 0 0.166667 0.8 0 0.2 0.8 0 0.233333 0.8 0 + 0.266667 0.8 0 0.3 0.8 0 0.333333 0.8 0 0.366667 0.8 0 + 0.4 0.8 0 0.433333 0.8 0 0.466667 0.8 0 0.5 0.8 0 + 0.533333 0.8 0 0.566667 0.8 0 0.6 0.8 0 0.633333 0.8 0 + 0.666667 0.8 0 0.7 0.8 0 0.733333 0.8 0 0.766667 0.8 0 + 0.8 0.8 0 0.833333 0.8 0 0.866667 0.8 0 0.9 0.8 0 + 0.933333 0.8 0 0.966667 0.8 0 1 0.8 0 0 0.833333 0 + 0.0333333 0.833333 0 0.0666667 0.833333 0 0.1 0.833333 0 0.133333 0.833333 0 + 0.166667 0.833333 0 0.2 0.833333 0 0.233333 0.833333 0 0.266667 0.833333 0 + 0.3 0.833333 0 0.333333 0.833333 0 0.366667 0.833333 0 0.4 0.833333 0 + 0.433333 0.833333 0 0.466667 0.833333 0 0.5 0.833333 0 0.533333 0.833333 0 + 0.566667 0.833333 0 0.6 0.833333 0 0.633333 0.833333 0 0.666667 0.833333 0 + 0.7 0.833333 0 0.733333 0.833333 0 0.766667 0.833333 0 0.8 0.833333 0 + 0.833333 0.833333 0 0.866667 0.833333 0 0.9 0.833333 0 0.933333 0.833333 0 + 0.966667 0.833333 0 1 0.833333 0 0 0.866667 0 0.0333333 0.866667 0 + 0.0666667 0.866667 0 0.1 0.866667 0 0.133333 0.866667 0 0.166667 0.866667 0 + 0.2 0.866667 0 0.233333 0.866667 0 0.266667 0.866667 0 0.3 0.866667 0 + 0.333333 0.866667 0 0.366667 0.866667 0 0.4 0.866667 0 0.433333 0.866667 0 + 0.466667 0.866667 0 0.5 0.866667 0 0.533333 0.866667 0 0.566667 0.866667 0 + 0.6 0.866667 0 0.633333 0.866667 0 0.666667 0.866667 0 0.7 0.866667 0 + 0.733333 0.866667 0 0.766667 0.866667 0 0.8 0.866667 0 0.833333 0.866667 0 + 0.866667 0.866667 0 0.9 0.866667 0 0.933333 0.866667 0 0.966667 0.866667 0 + 1 0.866667 0 0 0.9 0 0.0333333 0.9 0 0.0666667 0.9 0 + 0.1 0.9 0 0.133333 0.9 0 0.166667 0.9 0 0.2 0.9 0 + 0.233333 0.9 0 0.266667 0.9 0 0.3 0.9 0 0.333333 0.9 0 + 0.366667 0.9 0 0.4 0.9 0 0.433333 0.9 0 0.466667 0.9 0 + 0.5 0.9 0 0.533333 0.9 0 0.566667 0.9 0 0.6 0.9 0 + 0.633333 0.9 0 0.666667 0.9 0 0.7 0.9 0 0.733333 0.9 0 + 0.766667 0.9 0 0.8 0.9 0 0.833333 0.9 0 0.866667 0.9 0 + 0.9 0.9 0 0.933333 0.9 0 0.966667 0.9 0 1 0.9 0 + 0 0.933333 0 0.0333333 0.933333 0 0.0666667 0.933333 0 0.1 0.933333 0 + 0.133333 0.933333 0 0.166667 0.933333 0 0.2 0.933333 0 0.233333 0.933333 0 + 0.266667 0.933333 0 0.3 0.933333 0 0.333333 0.933333 0 0.366667 0.933333 0 + 0.4 0.933333 0 0.433333 0.933333 0 0.466667 0.933333 0 0.5 0.933333 0 + 0.533333 0.933333 0 0.566667 0.933333 0 0.6 0.933333 0 0.633333 0.933333 0 + 0.666667 0.933333 0 0.7 0.933333 0 0.733333 0.933333 0 0.766667 0.933333 0 + 0.8 0.933333 0 0.833333 0.933333 0 0.866667 0.933333 0 0.9 0.933333 0 + 0.933333 0.933333 0 0.966667 0.933333 0 1 0.933333 0 0 0.966667 0 + 0.0333333 0.966667 0 0.0666667 0.966667 0 0.1 0.966667 0 0.133333 0.966667 0 + 0.166667 0.966667 0 0.2 0.966667 0 0.233333 0.966667 0 0.266667 0.966667 0 + 0.3 0.966667 0 0.333333 0.966667 0 0.366667 0.966667 0 0.4 0.966667 0 + 0.433333 0.966667 0 0.466667 0.966667 0 0.5 0.966667 0 0.533333 0.966667 0 + 0.566667 0.966667 0 0.6 0.966667 0 0.633333 0.966667 0 0.666667 0.966667 0 + 0.7 0.966667 0 0.733333 0.966667 0 0.766667 0.966667 0 0.8 0.966667 0 + 0.833333 0.966667 0 0.866667 0.966667 0 0.9 0.966667 0 0.933333 0.966667 0 + 0.966667 0.966667 0 1 0.966667 0 0 1 0 0.0333333 1 0 + 0.0666667 1 0 0.1 1 0 0.133333 1 0 0.166667 1 0 + 0.2 1 0 0.233333 1 0 0.266667 1 0 0.3 1 0 + 0.333333 1 0 0.366667 1 0 0.4 1 0 0.433333 1 0 + 0.466667 1 0 0.5 1 0 0.533333 1 0 0.566667 1 0 + 0.6 1 0 0.633333 1 0 0.666667 1 0 0.7 1 0 + 0.733333 1 0 0.766667 1 0 0.8 1 0 0.833333 1 0 + 0.866667 1 0 0.9 1 0 0.933333 1 0 0.966667 1 0 + 1 1 0 + + + + + 0 1 3 2 1 4 5 3 4 6 7 5 + 6 8 9 7 8 10 11 9 10 12 13 11 + 12 14 15 13 14 16 17 15 16 18 19 17 + 18 20 21 19 20 22 23 21 22 24 25 23 + 24 26 27 25 26 28 29 27 28 30 31 29 + 30 32 33 31 32 34 35 33 34 36 37 35 + 36 38 39 37 38 40 41 39 40 42 43 41 + 42 44 45 43 44 46 47 45 46 48 49 47 + 48 50 51 49 50 52 53 51 52 54 55 53 + 54 56 57 55 56 58 59 57 58 60 61 59 + 2 3 63 62 3 5 64 63 5 7 65 64 + 7 9 66 65 9 11 67 66 11 13 68 67 + 13 15 69 68 15 17 70 69 17 19 71 70 + 19 21 72 71 21 23 73 72 23 25 74 73 + 25 27 75 74 27 29 76 75 29 31 77 76 + 31 33 78 77 33 35 79 78 35 37 80 79 + 37 39 81 80 39 41 82 81 41 43 83 82 + 43 45 84 83 45 47 85 84 47 49 86 85 + 49 51 87 86 51 53 88 87 53 55 89 88 + 55 57 90 89 57 59 91 90 59 61 92 91 + 62 63 94 93 63 64 95 94 64 65 96 95 + 65 66 97 96 66 67 98 97 67 68 99 98 + 68 69 100 99 69 70 101 100 70 71 102 101 + 71 72 103 102 72 73 104 103 73 74 105 104 + 74 75 106 105 75 76 107 106 76 77 108 107 + 77 78 109 108 78 79 110 109 79 80 111 110 + 80 81 112 111 81 82 113 112 82 83 114 113 + 83 84 115 114 84 85 116 115 85 86 117 116 + 86 87 118 117 87 88 119 118 88 89 120 119 + 89 90 121 120 90 91 122 121 91 92 123 122 + 93 94 125 124 94 95 126 125 95 96 127 126 + 96 97 128 127 97 98 129 128 98 99 130 129 + 99 100 131 130 100 101 132 131 101 102 133 132 + 102 103 134 133 103 104 135 134 104 105 136 135 + 105 106 137 136 106 107 138 137 107 108 139 138 + 108 109 140 139 109 110 141 140 110 111 142 141 + 111 112 143 142 112 113 144 143 113 114 145 144 + 114 115 146 145 115 116 147 146 116 117 148 147 + 117 118 149 148 118 119 150 149 119 120 151 150 + 120 121 152 151 121 122 153 152 122 123 154 153 + 124 125 156 155 125 126 157 156 126 127 158 157 + 127 128 159 158 128 129 160 159 129 130 161 160 + 130 131 162 161 131 132 163 162 132 133 164 163 + 133 134 165 164 134 135 166 165 135 136 167 166 + 136 137 168 167 137 138 169 168 138 139 170 169 + 139 140 171 170 140 141 172 171 141 142 173 172 + 142 143 174 173 143 144 175 174 144 145 176 175 + 145 146 177 176 146 147 178 177 147 148 179 178 + 148 149 180 179 149 150 181 180 150 151 182 181 + 151 152 183 182 152 153 184 183 153 154 185 184 + 155 156 187 186 156 157 188 187 157 158 189 188 + 158 159 190 189 159 160 191 190 160 161 192 191 + 161 162 193 192 162 163 194 193 163 164 195 194 + 164 165 196 195 165 166 197 196 166 167 198 197 + 167 168 199 198 168 169 200 199 169 170 201 200 + 170 171 202 201 171 172 203 202 172 173 204 203 + 173 174 205 204 174 175 206 205 175 176 207 206 + 176 177 208 207 177 178 209 208 178 179 210 209 + 179 180 211 210 180 181 212 211 181 182 213 212 + 182 183 214 213 183 184 215 214 184 185 216 215 + 186 187 218 217 187 188 219 218 188 189 220 219 + 189 190 221 220 190 191 222 221 191 192 223 222 + 192 193 224 223 193 194 225 224 194 195 226 225 + 195 196 227 226 196 197 228 227 197 198 229 228 + 198 199 230 229 199 200 231 230 200 201 232 231 + 201 202 233 232 202 203 234 233 203 204 235 234 + 204 205 236 235 205 206 237 236 206 207 238 237 + 207 208 239 238 208 209 240 239 209 210 241 240 + 210 211 242 241 211 212 243 242 212 213 244 243 + 213 214 245 244 214 215 246 245 215 216 247 246 + 217 218 249 248 218 219 250 249 219 220 251 250 + 220 221 252 251 221 222 253 252 222 223 254 253 + 223 224 255 254 224 225 256 255 225 226 257 256 + 226 227 258 257 227 228 259 258 228 229 260 259 + 229 230 261 260 230 231 262 261 231 232 263 262 + 232 233 264 263 233 234 265 264 234 235 266 265 + 235 236 267 266 236 237 268 267 237 238 269 268 + 238 239 270 269 239 240 271 270 240 241 272 271 + 241 242 273 272 242 243 274 273 243 244 275 274 + 244 245 276 275 245 246 277 276 246 247 278 277 + 248 249 280 279 249 250 281 280 250 251 282 281 + 251 252 283 282 252 253 284 283 253 254 285 284 + 254 255 286 285 255 256 287 286 256 257 288 287 + 257 258 289 288 258 259 290 289 259 260 291 290 + 260 261 292 291 261 262 293 292 262 263 294 293 + 263 264 295 294 264 265 296 295 265 266 297 296 + 266 267 298 297 267 268 299 298 268 269 300 299 + 269 270 301 300 270 271 302 301 271 272 303 302 + 272 273 304 303 273 274 305 304 274 275 306 305 + 275 276 307 306 276 277 308 307 277 278 309 308 + 279 280 311 310 280 281 312 311 281 282 313 312 + 282 283 314 313 283 284 315 314 284 285 316 315 + 285 286 317 316 286 287 318 317 287 288 319 318 + 288 289 320 319 289 290 321 320 290 291 322 321 + 291 292 323 322 292 293 324 323 293 294 325 324 + 294 295 326 325 295 296 327 326 296 297 328 327 + 297 298 329 328 298 299 330 329 299 300 331 330 + 300 301 332 331 301 302 333 332 302 303 334 333 + 303 304 335 334 304 305 336 335 305 306 337 336 + 306 307 338 337 307 308 339 338 308 309 340 339 + 310 311 342 341 311 312 343 342 312 313 344 343 + 313 314 345 344 314 315 346 345 315 316 347 346 + 316 317 348 347 317 318 349 348 318 319 350 349 + 319 320 351 350 320 321 352 351 321 322 353 352 + 322 323 354 353 323 324 355 354 324 325 356 355 + 325 326 357 356 326 327 358 357 327 328 359 358 + 328 329 360 359 329 330 361 360 330 331 362 361 + 331 332 363 362 332 333 364 363 333 334 365 364 + 334 335 366 365 335 336 367 366 336 337 368 367 + 337 338 369 368 338 339 370 369 339 340 371 370 + 341 342 373 372 342 343 374 373 343 344 375 374 + 344 345 376 375 345 346 377 376 346 347 378 377 + 347 348 379 378 348 349 380 379 349 350 381 380 + 350 351 382 381 351 352 383 382 352 353 384 383 + 353 354 385 384 354 355 386 385 355 356 387 386 + 356 357 388 387 357 358 389 388 358 359 390 389 + 359 360 391 390 360 361 392 391 361 362 393 392 + 362 363 394 393 363 364 395 394 364 365 396 395 + 365 366 397 396 366 367 398 397 367 368 399 398 + 368 369 400 399 369 370 401 400 370 371 402 401 + 372 373 404 403 373 374 405 404 374 375 406 405 + 375 376 407 406 376 377 408 407 377 378 409 408 + 378 379 410 409 379 380 411 410 380 381 412 411 + 381 382 413 412 382 383 414 413 383 384 415 414 + 384 385 416 415 385 386 417 416 386 387 418 417 + 387 388 419 418 388 389 420 419 389 390 421 420 + 390 391 422 421 391 392 423 422 392 393 424 423 + 393 394 425 424 394 395 426 425 395 396 427 426 + 396 397 428 427 397 398 429 428 398 399 430 429 + 399 400 431 430 400 401 432 431 401 402 433 432 + 403 404 435 434 404 405 436 435 405 406 437 436 + 406 407 438 437 407 408 439 438 408 409 440 439 + 409 410 441 440 410 411 442 441 411 412 443 442 + 412 413 444 443 413 414 445 444 414 415 446 445 + 415 416 447 446 416 417 448 447 417 418 449 448 + 418 419 450 449 419 420 451 450 420 421 452 451 + 421 422 453 452 422 423 454 453 423 424 455 454 + 424 425 456 455 425 426 457 456 426 427 458 457 + 427 428 459 458 428 429 460 459 429 430 461 460 + 430 431 462 461 431 432 463 462 432 433 464 463 + 434 435 466 465 435 436 467 466 436 437 468 467 + 437 438 469 468 438 439 470 469 439 440 471 470 + 440 441 472 471 441 442 473 472 442 443 474 473 + 443 444 475 474 444 445 476 475 445 446 477 476 + 446 447 478 477 447 448 479 478 448 449 480 479 + 449 450 481 480 450 451 482 481 451 452 483 482 + 452 453 484 483 453 454 485 484 454 455 486 485 + 455 456 487 486 456 457 488 487 457 458 489 488 + 458 459 490 489 459 460 491 490 460 461 492 491 + 461 462 493 492 462 463 494 493 463 464 495 494 + 465 466 497 496 466 467 498 497 467 468 499 498 + 468 469 500 499 469 470 501 500 470 471 502 501 + 471 472 503 502 472 473 504 503 473 474 505 504 + 474 475 506 505 475 476 507 506 476 477 508 507 + 477 478 509 508 478 479 510 509 479 480 511 510 + 480 481 512 511 481 482 513 512 482 483 514 513 + 483 484 515 514 484 485 516 515 485 486 517 516 + 486 487 518 517 487 488 519 518 488 489 520 519 + 489 490 521 520 490 491 522 521 491 492 523 522 + 492 493 524 523 493 494 525 524 494 495 526 525 + 496 497 528 527 497 498 529 528 498 499 530 529 + 499 500 531 530 500 501 532 531 501 502 533 532 + 502 503 534 533 503 504 535 534 504 505 536 535 + 505 506 537 536 506 507 538 537 507 508 539 538 + 508 509 540 539 509 510 541 540 510 511 542 541 + 511 512 543 542 512 513 544 543 513 514 545 544 + 514 515 546 545 515 516 547 546 516 517 548 547 + 517 518 549 548 518 519 550 549 519 520 551 550 + 520 521 552 551 521 522 553 552 522 523 554 553 + 523 524 555 554 524 525 556 555 525 526 557 556 + 527 528 559 558 528 529 560 559 529 530 561 560 + 530 531 562 561 531 532 563 562 532 533 564 563 + 533 534 565 564 534 535 566 565 535 536 567 566 + 536 537 568 567 537 538 569 568 538 539 570 569 + 539 540 571 570 540 541 572 571 541 542 573 572 + 542 543 574 573 543 544 575 574 544 545 576 575 + 545 546 577 576 546 547 578 577 547 548 579 578 + 548 549 580 579 549 550 581 580 550 551 582 581 + 551 552 583 582 552 553 584 583 553 554 585 584 + 554 555 586 585 555 556 587 586 556 557 588 587 + 558 559 590 589 559 560 591 590 560 561 592 591 + 561 562 593 592 562 563 594 593 563 564 595 594 + 564 565 596 595 565 566 597 596 566 567 598 597 + 567 568 599 598 568 569 600 599 569 570 601 600 + 570 571 602 601 571 572 603 602 572 573 604 603 + 573 574 605 604 574 575 606 605 575 576 607 606 + 576 577 608 607 577 578 609 608 578 579 610 609 + 579 580 611 610 580 581 612 611 581 582 613 612 + 582 583 614 613 583 584 615 614 584 585 616 615 + 585 586 617 616 586 587 618 617 587 588 619 618 + 589 590 621 620 590 591 622 621 591 592 623 622 + 592 593 624 623 593 594 625 624 594 595 626 625 + 595 596 627 626 596 597 628 627 597 598 629 628 + 598 599 630 629 599 600 631 630 600 601 632 631 + 601 602 633 632 602 603 634 633 603 604 635 634 + 604 605 636 635 605 606 637 636 606 607 638 637 + 607 608 639 638 608 609 640 639 609 610 641 640 + 610 611 642 641 611 612 643 642 612 613 644 643 + 613 614 645 644 614 615 646 645 615 616 647 646 + 616 617 648 647 617 618 649 648 618 619 650 649 + 620 621 652 651 621 622 653 652 622 623 654 653 + 623 624 655 654 624 625 656 655 625 626 657 656 + 626 627 658 657 627 628 659 658 628 629 660 659 + 629 630 661 660 630 631 662 661 631 632 663 662 + 632 633 664 663 633 634 665 664 634 635 666 665 + 635 636 667 666 636 637 668 667 637 638 669 668 + 638 639 670 669 639 640 671 670 640 641 672 671 + 641 642 673 672 642 643 674 673 643 644 675 674 + 644 645 676 675 645 646 677 676 646 647 678 677 + 647 648 679 678 648 649 680 679 649 650 681 680 + 651 652 683 682 652 653 684 683 653 654 685 684 + 654 655 686 685 655 656 687 686 656 657 688 687 + 657 658 689 688 658 659 690 689 659 660 691 690 + 660 661 692 691 661 662 693 692 662 663 694 693 + 663 664 695 694 664 665 696 695 665 666 697 696 + 666 667 698 697 667 668 699 698 668 669 700 699 + 669 670 701 700 670 671 702 701 671 672 703 702 + 672 673 704 703 673 674 705 704 674 675 706 705 + 675 676 707 706 676 677 708 707 677 678 709 708 + 678 679 710 709 679 680 711 710 680 681 712 711 + 682 683 714 713 683 684 715 714 684 685 716 715 + 685 686 717 716 686 687 718 717 687 688 719 718 + 688 689 720 719 689 690 721 720 690 691 722 721 + 691 692 723 722 692 693 724 723 693 694 725 724 + 694 695 726 725 695 696 727 726 696 697 728 727 + 697 698 729 728 698 699 730 729 699 700 731 730 + 700 701 732 731 701 702 733 732 702 703 734 733 + 703 704 735 734 704 705 736 735 705 706 737 736 + 706 707 738 737 707 708 739 738 708 709 740 739 + 709 710 741 740 710 711 742 741 711 712 743 742 + 713 714 745 744 714 715 746 745 715 716 747 746 + 716 717 748 747 717 718 749 748 718 719 750 749 + 719 720 751 750 720 721 752 751 721 722 753 752 + 722 723 754 753 723 724 755 754 724 725 756 755 + 725 726 757 756 726 727 758 757 727 728 759 758 + 728 729 760 759 729 730 761 760 730 731 762 761 + 731 732 763 762 732 733 764 763 733 734 765 764 + 734 735 766 765 735 736 767 766 736 737 768 767 + 737 738 769 768 738 739 770 769 739 740 771 770 + 740 741 772 771 741 742 773 772 742 743 774 773 + 744 745 776 775 745 746 777 776 746 747 778 777 + 747 748 779 778 748 749 780 779 749 750 781 780 + 750 751 782 781 751 752 783 782 752 753 784 783 + 753 754 785 784 754 755 786 785 755 756 787 786 + 756 757 788 787 757 758 789 788 758 759 790 789 + 759 760 791 790 760 761 792 791 761 762 793 792 + 762 763 794 793 763 764 795 794 764 765 796 795 + 765 766 797 796 766 767 798 797 767 768 799 798 + 768 769 800 799 769 770 801 800 770 771 802 801 + 771 772 803 802 772 773 804 803 773 774 805 804 + 775 776 807 806 776 777 808 807 777 778 809 808 + 778 779 810 809 779 780 811 810 780 781 812 811 + 781 782 813 812 782 783 814 813 783 784 815 814 + 784 785 816 815 785 786 817 816 786 787 818 817 + 787 788 819 818 788 789 820 819 789 790 821 820 + 790 791 822 821 791 792 823 822 792 793 824 823 + 793 794 825 824 794 795 826 825 795 796 827 826 + 796 797 828 827 797 798 829 828 798 799 830 829 + 799 800 831 830 800 801 832 831 801 802 833 832 + 802 803 834 833 803 804 835 834 804 805 836 835 + 806 807 838 837 807 808 839 838 808 809 840 839 + 809 810 841 840 810 811 842 841 811 812 843 842 + 812 813 844 843 813 814 845 844 814 815 846 845 + 815 816 847 846 816 817 848 847 817 818 849 848 + 818 819 850 849 819 820 851 850 820 821 852 851 + 821 822 853 852 822 823 854 853 823 824 855 854 + 824 825 856 855 825 826 857 856 826 827 858 857 + 827 828 859 858 828 829 860 859 829 830 861 860 + 830 831 862 861 831 832 863 862 832 833 864 863 + 833 834 865 864 834 835 866 865 835 836 867 866 + 837 838 869 868 838 839 870 869 839 840 871 870 + 840 841 872 871 841 842 873 872 842 843 874 873 + 843 844 875 874 844 845 876 875 845 846 877 876 + 846 847 878 877 847 848 879 878 848 849 880 879 + 849 850 881 880 850 851 882 881 851 852 883 882 + 852 853 884 883 853 854 885 884 854 855 886 885 + 855 856 887 886 856 857 888 887 857 858 889 888 + 858 859 890 889 859 860 891 890 860 861 892 891 + 861 862 893 892 862 863 894 893 863 864 895 894 + 864 865 896 895 865 866 897 896 866 867 898 897 + 868 869 900 899 869 870 901 900 870 871 902 901 + 871 872 903 902 872 873 904 903 873 874 905 904 + 874 875 906 905 875 876 907 906 876 877 908 907 + 877 878 909 908 878 879 910 909 879 880 911 910 + 880 881 912 911 881 882 913 912 882 883 914 913 + 883 884 915 914 884 885 916 915 885 886 917 916 + 886 887 918 917 887 888 919 918 888 889 920 919 + 889 890 921 920 890 891 922 921 891 892 923 922 + 892 893 924 923 893 894 925 924 894 895 926 925 + 895 896 927 926 896 897 928 927 897 898 929 928 + 899 900 931 930 900 901 932 931 901 902 933 932 + 902 903 934 933 903 904 935 934 904 905 936 935 + 905 906 937 936 906 907 938 937 907 908 939 938 + 908 909 940 939 909 910 941 940 910 911 942 941 + 911 912 943 942 912 913 944 943 913 914 945 944 + 914 915 946 945 915 916 947 946 916 917 948 947 + 917 918 949 948 918 919 950 949 919 920 951 950 + 920 921 952 951 921 922 953 952 922 923 954 953 + 923 924 955 954 924 925 956 955 925 926 957 956 + 926 927 958 957 927 928 959 958 928 929 960 959 + + + 4 8 12 16 20 24 28 32 36 40 44 48 + 52 56 60 64 68 72 76 80 84 88 92 96 + 100 104 108 112 116 120 124 128 132 136 140 144 + 148 152 156 160 164 168 172 176 180 184 188 192 + 196 200 204 208 212 216 220 224 228 232 236 240 + 244 248 252 256 260 264 268 272 276 280 284 288 + 292 296 300 304 308 312 316 320 324 328 332 336 + 340 344 348 352 356 360 364 368 372 376 380 384 + 388 392 396 400 404 408 412 416 420 424 428 432 + 436 440 444 448 452 456 460 464 468 472 476 480 + 484 488 492 496 500 504 508 512 516 520 524 528 + 532 536 540 544 548 552 556 560 564 568 572 576 + 580 584 588 592 596 600 604 608 612 616 620 624 + 628 632 636 640 644 648 652 656 660 664 668 672 + 676 680 684 688 692 696 700 704 708 712 716 720 + 724 728 732 736 740 744 748 752 756 760 764 768 + 772 776 780 784 788 792 796 800 804 808 812 816 + 820 824 828 832 836 840 844 848 852 856 860 864 + 868 872 876 880 884 888 892 896 900 904 908 912 + 916 920 924 928 932 936 940 944 948 952 956 960 + 964 968 972 976 980 984 988 992 996 1000 1004 1008 + 1012 1016 1020 1024 1028 1032 1036 1040 1044 1048 1052 1056 + 1060 1064 1068 1072 1076 1080 1084 1088 1092 1096 1100 1104 + 1108 1112 1116 1120 1124 1128 1132 1136 1140 1144 1148 1152 + 1156 1160 1164 1168 1172 1176 1180 1184 1188 1192 1196 1200 + 1204 1208 1212 1216 1220 1224 1228 1232 1236 1240 1244 1248 + 1252 1256 1260 1264 1268 1272 1276 1280 1284 1288 1292 1296 + 1300 1304 1308 1312 1316 1320 1324 1328 1332 1336 1340 1344 + 1348 1352 1356 1360 1364 1368 1372 1376 1380 1384 1388 1392 + 1396 1400 1404 1408 1412 1416 1420 1424 1428 1432 1436 1440 + 1444 1448 1452 1456 1460 1464 1468 1472 1476 1480 1484 1488 + 1492 1496 1500 1504 1508 1512 1516 1520 1524 1528 1532 1536 + 1540 1544 1548 1552 1556 1560 1564 1568 1572 1576 1580 1584 + 1588 1592 1596 1600 1604 1608 1612 1616 1620 1624 1628 1632 + 1636 1640 1644 1648 1652 1656 1660 1664 1668 1672 1676 1680 + 1684 1688 1692 1696 1700 1704 1708 1712 1716 1720 1724 1728 + 1732 1736 1740 1744 1748 1752 1756 1760 1764 1768 1772 1776 + 1780 1784 1788 1792 1796 1800 1804 1808 1812 1816 1820 1824 + 1828 1832 1836 1840 1844 1848 1852 1856 1860 1864 1868 1872 + 1876 1880 1884 1888 1892 1896 1900 1904 1908 1912 1916 1920 + 1924 1928 1932 1936 1940 1944 1948 1952 1956 1960 1964 1968 + 1972 1976 1980 1984 1988 1992 1996 2000 2004 2008 2012 2016 + 2020 2024 2028 2032 2036 2040 2044 2048 2052 2056 2060 2064 + 2068 2072 2076 2080 2084 2088 2092 2096 2100 2104 2108 2112 + 2116 2120 2124 2128 2132 2136 2140 2144 2148 2152 2156 2160 + 2164 2168 2172 2176 2180 2184 2188 2192 2196 2200 2204 2208 + 2212 2216 2220 2224 2228 2232 2236 2240 2244 2248 2252 2256 + 2260 2264 2268 2272 2276 2280 2284 2288 2292 2296 2300 2304 + 2308 2312 2316 2320 2324 2328 2332 2336 2340 2344 2348 2352 + 2356 2360 2364 2368 2372 2376 2380 2384 2388 2392 2396 2400 + 2404 2408 2412 2416 2420 2424 2428 2432 2436 2440 2444 2448 + 2452 2456 2460 2464 2468 2472 2476 2480 2484 2488 2492 2496 + 2500 2504 2508 2512 2516 2520 2524 2528 2532 2536 2540 2544 + 2548 2552 2556 2560 2564 2568 2572 2576 2580 2584 2588 2592 + 2596 2600 2604 2608 2612 2616 2620 2624 2628 2632 2636 2640 + 2644 2648 2652 2656 2660 2664 2668 2672 2676 2680 2684 2688 + 2692 2696 2700 2704 2708 2712 2716 2720 2724 2728 2732 2736 + 2740 2744 2748 2752 2756 2760 2764 2768 2772 2776 2780 2784 + 2788 2792 2796 2800 2804 2808 2812 2816 2820 2824 2828 2832 + 2836 2840 2844 2848 2852 2856 2860 2864 2868 2872 2876 2880 + 2884 2888 2892 2896 2900 2904 2908 2912 2916 2920 2924 2928 + 2932 2936 2940 2944 2948 2952 2956 2960 2964 2968 2972 2976 + 2980 2984 2988 2992 2996 3000 3004 3008 3012 3016 3020 3024 + 3028 3032 3036 3040 3044 3048 3052 3056 3060 3064 3068 3072 + 3076 3080 3084 3088 3092 3096 3100 3104 3108 3112 3116 3120 + 3124 3128 3132 3136 3140 3144 3148 3152 3156 3160 3164 3168 + 3172 3176 3180 3184 3188 3192 3196 3200 3204 3208 3212 3216 + 3220 3224 3228 3232 3236 3240 3244 3248 3252 3256 3260 3264 + 3268 3272 3276 3280 3284 3288 3292 3296 3300 3304 3308 3312 + 3316 3320 3324 3328 3332 3336 3340 3344 3348 3352 3356 3360 + 3364 3368 3372 3376 3380 3384 3388 3392 3396 3400 3404 3408 + 3412 3416 3420 3424 3428 3432 3436 3440 3444 3448 3452 3456 + 3460 3464 3468 3472 3476 3480 3484 3488 3492 3496 3500 3504 + 3508 3512 3516 3520 3524 3528 3532 3536 3540 3544 3548 3552 + 3556 3560 3564 3568 3572 3576 3580 3584 3588 3592 3596 3600 + + + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + + + + + diff --git a/test/references/cctracermaxwellstefan-reference.vtu b/test/references/cctracermaxwellstefan-reference.vtu new file mode 100644 index 0000000000000000000000000000000000000000..da22d32047ce308d8d115b17fe0b93f161d61c31 --- /dev/null +++ b/test/references/cctracermaxwellstefan-reference.vtu @@ -0,0 +1,1555 @@ + + + + + + + 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 + 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 + 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 + 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 + 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 + 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 + 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 + 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 + 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 + 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 + 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 + 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 + 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 + 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 + 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 + 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 + 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 + 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 + 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 + 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 + 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 + 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 + 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 + 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 + 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 + 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 + 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 + 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 + 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 + 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 + 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 + 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 + 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 + 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 + 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 + 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 + 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 + 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 + 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 + 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 + 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 + 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 + 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 + 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 + 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 + 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 + 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 + 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 + 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 + 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 + 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 + 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 + 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 + 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 + 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 + 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 + 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 + 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 + 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 + 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 + 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 + 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 + 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 + 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 + 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 + 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 + 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 + 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 + 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 + 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 + 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 + 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 + 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 0.250566 0.250567 0.250567 0.250569 0.25057 0.250572 + 0.250575 0.250577 0.25058 0.250584 0.250587 0.250591 0.250595 0.250599 0.250603 0.250607 0.250611 0.250615 + 0.250619 0.250623 0.250626 0.25063 0.250633 0.250635 0.250638 0.25064 0.250641 0.250643 0.250643 0.250644 + + + 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 + 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 + 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 + 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 + 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 + 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 + 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 + 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 + 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 + 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 + 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 + 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 + 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 + 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 + 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 + 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 + 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 + 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 + 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 + 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 + 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 + 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 + 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 + 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 + 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 + 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 + 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 + 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 + 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 + 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 + 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 + 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 + 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 + 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 + 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 + 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 + 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 + 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 + 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 + 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 + 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 + 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 + 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 + 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 + 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 + 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 + 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 + 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 + 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 + 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 + 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 + 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 + 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 + 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 + 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 + 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 + 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 + 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 + 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 + 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 + 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 + 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 + 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 + 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 + 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 + 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 + 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 + 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 + 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 + 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 + 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 + 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 + 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 0.0173043 0.0173043 0.0173044 0.0173045 0.0173046 0.0173047 + 0.0173049 0.0173051 0.0173053 0.0173055 0.0173058 0.017306 0.0173063 0.0173066 0.0173068 0.0173071 0.0173074 0.0173077 + 0.0173079 0.0173082 0.0173084 0.0173087 0.0173089 0.0173091 0.0173092 0.0173094 0.0173095 0.0173096 0.0173096 0.0173097 + + + 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 + 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 + 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 + 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 + 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 + 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 + 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 + 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 + 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 + 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 + 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 + 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 + 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 + 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 + 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 + 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 + 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 + 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 + 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 + 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 + 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 + 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 + 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 + 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 + 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 + 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 + 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 + 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 + 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 + 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 + 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 + 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 + 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 + 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 + 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 + 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 + 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 + 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 + 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 + 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 + 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 + 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 + 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 + 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 + 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 + 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 + 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 + 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 + 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 + 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 + 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 + 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 + 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 + 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 + 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 + 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 + 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 + 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 + 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 + 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 + 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 + 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 + 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 + 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 + 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 + 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 + 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 + 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 + 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 + 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 + 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 + 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 + 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 0.498062 0.498081 0.498119 0.498176 0.498251 0.498344 + 0.498452 0.498576 0.498713 0.498862 0.499022 0.499191 0.499367 0.499548 0.499732 0.499917 0.5001 0.500281 + 0.500457 0.500626 0.500787 0.500937 0.501074 0.501198 0.501307 0.5014 0.501475 0.501532 0.501571 0.50159 + + + 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 + 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 + 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 + 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 + 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 + 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 + 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 + 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 + 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 + 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 + 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 + 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 + 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 + 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 + 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 + 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 + 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 + 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 + 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 + 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 + 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 + 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 + 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 + 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 + 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 + 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 + 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 + 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 + 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 + 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 + 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 + 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 + 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 + 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 + 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 + 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 + 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 + 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 + 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 + 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 + 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 + 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 + 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 + 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 + 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 + 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 + 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 + 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 + 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 + 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 + 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 + 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 + 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 + 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 + 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 + 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 + 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 + 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 + 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 + 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 + 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 + 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 + 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 + 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 + 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 + 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 + 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 + 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 + 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 + 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 + 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 + 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 + 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 0.481551 0.48157 0.481607 0.481662 0.481735 0.481824 + 0.481929 0.482048 0.482181 0.482326 0.48248 0.482643 0.482813 0.482988 0.483166 0.483345 0.483523 0.483698 + 0.483868 0.484031 0.484186 0.484331 0.484464 0.484584 0.484689 0.484779 0.484851 0.484907 0.484944 0.484963 + + + 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 + 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 + 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 + 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 + 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 + 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 + 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 + 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 + 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 + 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 + 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 + 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 + 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 + 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 + 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 + 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 + 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 + 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 + 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 + 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 + 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 + 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 + 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 + 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 + 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 + 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 + 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 + 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 + 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 + 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 + 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 + 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 + 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 + 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 + 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 + 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 + 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 + 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 + 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 + 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 + 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 + 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 + 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 + 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 + 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 + 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 + 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 + 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 + 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 + 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 + 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 + 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 + 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 + 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 + 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 + 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 + 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 + 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 + 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 + 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 + 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 + 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 + 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 + 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 + 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 + 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 + 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 + 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 + 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 + 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 + 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 + 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 + 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 0.251372 0.251352 0.251313 0.251255 0.251178 0.251084 + 0.250973 0.250847 0.250706 0.250554 0.25039 0.250218 0.250038 0.249853 0.249665 0.249476 0.249288 0.249104 + 0.248924 0.248751 0.248587 0.248434 0.248293 0.248167 0.248055 0.247961 0.247884 0.247825 0.247786 0.247766 + + + 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 + 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 + 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 + 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 + 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 + 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 + 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 + 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 + 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 + 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 + 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 + 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 + 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 + 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 + 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 + 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 + 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 + 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 + 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 + 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 + 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 + 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 + 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 + 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 + 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 + 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 + 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 + 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 + 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 + 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 + 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 + 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 + 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 + 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 + 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 + 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 + 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 + 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 + 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 + 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 + 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 + 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 + 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 + 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 + 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 + 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 + 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 + 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 + 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 + 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 + 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 + 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 + 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 + 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 + 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 + 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 + 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 + 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 + 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 + 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 + 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 + 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 + 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 + 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 + 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 + 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 + 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 + 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 + 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 + 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 + 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 + 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 + 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 0.381919 0.381889 0.381829 0.381741 0.381624 0.381481 + 0.381313 0.381121 0.380908 0.380676 0.380427 0.380165 0.379892 0.379611 0.379326 0.379039 0.378753 0.378472 + 0.378199 0.377936 0.377687 0.377455 0.377241 0.377049 0.37688 0.376736 0.376619 0.37653 0.37647 0.37644 + + + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + + + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 -0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 -0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 -0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 -0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 -0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 -0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 -0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 -0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 -0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 -0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 -0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 -0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 -0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 -0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 0 -0 0 0 -0 0 + 0 -0 0 0 -0 0 0 -0 0 0 -0 0 + 0 -0 0 0 -0 0 0 -0 0 0 -0 0 + 0 -0 0 0 -0 0 0 -0 0 0 -0 0 + 0 -0 0 0 -0 0 0 -0 0 0 -0 0 + 0 -0 0 0 -0 0 0 -0 0 0 -0 0 + 0 -0 0 0 -0 0 0 -0 0 0 -0 0 + 0 -0 0 0 -0 0 0 -0 0 -0 -0 0 + + + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + + + + + 0 0 0 0.0333333 0 0 0 0.0333333 0 0.0333333 0.0333333 0 + 0.0666667 0 0 0.0666667 0.0333333 0 0.1 0 0 0.1 0.0333333 0 + 0.133333 0 0 0.133333 0.0333333 0 0.166667 0 0 0.166667 0.0333333 0 + 0.2 0 0 0.2 0.0333333 0 0.233333 0 0 0.233333 0.0333333 0 + 0.266667 0 0 0.266667 0.0333333 0 0.3 0 0 0.3 0.0333333 0 + 0.333333 0 0 0.333333 0.0333333 0 0.366667 0 0 0.366667 0.0333333 0 + 0.4 0 0 0.4 0.0333333 0 0.433333 0 0 0.433333 0.0333333 0 + 0.466667 0 0 0.466667 0.0333333 0 0.5 0 0 0.5 0.0333333 0 + 0.533333 0 0 0.533333 0.0333333 0 0.566667 0 0 0.566667 0.0333333 0 + 0.6 0 0 0.6 0.0333333 0 0.633333 0 0 0.633333 0.0333333 0 + 0.666667 0 0 0.666667 0.0333333 0 0.7 0 0 0.7 0.0333333 0 + 0.733333 0 0 0.733333 0.0333333 0 0.766667 0 0 0.766667 0.0333333 0 + 0.8 0 0 0.8 0.0333333 0 0.833333 0 0 0.833333 0.0333333 0 + 0.866667 0 0 0.866667 0.0333333 0 0.9 0 0 0.9 0.0333333 0 + 0.933333 0 0 0.933333 0.0333333 0 0.966667 0 0 0.966667 0.0333333 0 + 1 0 0 1 0.0333333 0 0 0.0666667 0 0.0333333 0.0666667 0 + 0.0666667 0.0666667 0 0.1 0.0666667 0 0.133333 0.0666667 0 0.166667 0.0666667 0 + 0.2 0.0666667 0 0.233333 0.0666667 0 0.266667 0.0666667 0 0.3 0.0666667 0 + 0.333333 0.0666667 0 0.366667 0.0666667 0 0.4 0.0666667 0 0.433333 0.0666667 0 + 0.466667 0.0666667 0 0.5 0.0666667 0 0.533333 0.0666667 0 0.566667 0.0666667 0 + 0.6 0.0666667 0 0.633333 0.0666667 0 0.666667 0.0666667 0 0.7 0.0666667 0 + 0.733333 0.0666667 0 0.766667 0.0666667 0 0.8 0.0666667 0 0.833333 0.0666667 0 + 0.866667 0.0666667 0 0.9 0.0666667 0 0.933333 0.0666667 0 0.966667 0.0666667 0 + 1 0.0666667 0 0 0.1 0 0.0333333 0.1 0 0.0666667 0.1 0 + 0.1 0.1 0 0.133333 0.1 0 0.166667 0.1 0 0.2 0.1 0 + 0.233333 0.1 0 0.266667 0.1 0 0.3 0.1 0 0.333333 0.1 0 + 0.366667 0.1 0 0.4 0.1 0 0.433333 0.1 0 0.466667 0.1 0 + 0.5 0.1 0 0.533333 0.1 0 0.566667 0.1 0 0.6 0.1 0 + 0.633333 0.1 0 0.666667 0.1 0 0.7 0.1 0 0.733333 0.1 0 + 0.766667 0.1 0 0.8 0.1 0 0.833333 0.1 0 0.866667 0.1 0 + 0.9 0.1 0 0.933333 0.1 0 0.966667 0.1 0 1 0.1 0 + 0 0.133333 0 0.0333333 0.133333 0 0.0666667 0.133333 0 0.1 0.133333 0 + 0.133333 0.133333 0 0.166667 0.133333 0 0.2 0.133333 0 0.233333 0.133333 0 + 0.266667 0.133333 0 0.3 0.133333 0 0.333333 0.133333 0 0.366667 0.133333 0 + 0.4 0.133333 0 0.433333 0.133333 0 0.466667 0.133333 0 0.5 0.133333 0 + 0.533333 0.133333 0 0.566667 0.133333 0 0.6 0.133333 0 0.633333 0.133333 0 + 0.666667 0.133333 0 0.7 0.133333 0 0.733333 0.133333 0 0.766667 0.133333 0 + 0.8 0.133333 0 0.833333 0.133333 0 0.866667 0.133333 0 0.9 0.133333 0 + 0.933333 0.133333 0 0.966667 0.133333 0 1 0.133333 0 0 0.166667 0 + 0.0333333 0.166667 0 0.0666667 0.166667 0 0.1 0.166667 0 0.133333 0.166667 0 + 0.166667 0.166667 0 0.2 0.166667 0 0.233333 0.166667 0 0.266667 0.166667 0 + 0.3 0.166667 0 0.333333 0.166667 0 0.366667 0.166667 0 0.4 0.166667 0 + 0.433333 0.166667 0 0.466667 0.166667 0 0.5 0.166667 0 0.533333 0.166667 0 + 0.566667 0.166667 0 0.6 0.166667 0 0.633333 0.166667 0 0.666667 0.166667 0 + 0.7 0.166667 0 0.733333 0.166667 0 0.766667 0.166667 0 0.8 0.166667 0 + 0.833333 0.166667 0 0.866667 0.166667 0 0.9 0.166667 0 0.933333 0.166667 0 + 0.966667 0.166667 0 1 0.166667 0 0 0.2 0 0.0333333 0.2 0 + 0.0666667 0.2 0 0.1 0.2 0 0.133333 0.2 0 0.166667 0.2 0 + 0.2 0.2 0 0.233333 0.2 0 0.266667 0.2 0 0.3 0.2 0 + 0.333333 0.2 0 0.366667 0.2 0 0.4 0.2 0 0.433333 0.2 0 + 0.466667 0.2 0 0.5 0.2 0 0.533333 0.2 0 0.566667 0.2 0 + 0.6 0.2 0 0.633333 0.2 0 0.666667 0.2 0 0.7 0.2 0 + 0.733333 0.2 0 0.766667 0.2 0 0.8 0.2 0 0.833333 0.2 0 + 0.866667 0.2 0 0.9 0.2 0 0.933333 0.2 0 0.966667 0.2 0 + 1 0.2 0 0 0.233333 0 0.0333333 0.233333 0 0.0666667 0.233333 0 + 0.1 0.233333 0 0.133333 0.233333 0 0.166667 0.233333 0 0.2 0.233333 0 + 0.233333 0.233333 0 0.266667 0.233333 0 0.3 0.233333 0 0.333333 0.233333 0 + 0.366667 0.233333 0 0.4 0.233333 0 0.433333 0.233333 0 0.466667 0.233333 0 + 0.5 0.233333 0 0.533333 0.233333 0 0.566667 0.233333 0 0.6 0.233333 0 + 0.633333 0.233333 0 0.666667 0.233333 0 0.7 0.233333 0 0.733333 0.233333 0 + 0.766667 0.233333 0 0.8 0.233333 0 0.833333 0.233333 0 0.866667 0.233333 0 + 0.9 0.233333 0 0.933333 0.233333 0 0.966667 0.233333 0 1 0.233333 0 + 0 0.266667 0 0.0333333 0.266667 0 0.0666667 0.266667 0 0.1 0.266667 0 + 0.133333 0.266667 0 0.166667 0.266667 0 0.2 0.266667 0 0.233333 0.266667 0 + 0.266667 0.266667 0 0.3 0.266667 0 0.333333 0.266667 0 0.366667 0.266667 0 + 0.4 0.266667 0 0.433333 0.266667 0 0.466667 0.266667 0 0.5 0.266667 0 + 0.533333 0.266667 0 0.566667 0.266667 0 0.6 0.266667 0 0.633333 0.266667 0 + 0.666667 0.266667 0 0.7 0.266667 0 0.733333 0.266667 0 0.766667 0.266667 0 + 0.8 0.266667 0 0.833333 0.266667 0 0.866667 0.266667 0 0.9 0.266667 0 + 0.933333 0.266667 0 0.966667 0.266667 0 1 0.266667 0 0 0.3 0 + 0.0333333 0.3 0 0.0666667 0.3 0 0.1 0.3 0 0.133333 0.3 0 + 0.166667 0.3 0 0.2 0.3 0 0.233333 0.3 0 0.266667 0.3 0 + 0.3 0.3 0 0.333333 0.3 0 0.366667 0.3 0 0.4 0.3 0 + 0.433333 0.3 0 0.466667 0.3 0 0.5 0.3 0 0.533333 0.3 0 + 0.566667 0.3 0 0.6 0.3 0 0.633333 0.3 0 0.666667 0.3 0 + 0.7 0.3 0 0.733333 0.3 0 0.766667 0.3 0 0.8 0.3 0 + 0.833333 0.3 0 0.866667 0.3 0 0.9 0.3 0 0.933333 0.3 0 + 0.966667 0.3 0 1 0.3 0 0 0.333333 0 0.0333333 0.333333 0 + 0.0666667 0.333333 0 0.1 0.333333 0 0.133333 0.333333 0 0.166667 0.333333 0 + 0.2 0.333333 0 0.233333 0.333333 0 0.266667 0.333333 0 0.3 0.333333 0 + 0.333333 0.333333 0 0.366667 0.333333 0 0.4 0.333333 0 0.433333 0.333333 0 + 0.466667 0.333333 0 0.5 0.333333 0 0.533333 0.333333 0 0.566667 0.333333 0 + 0.6 0.333333 0 0.633333 0.333333 0 0.666667 0.333333 0 0.7 0.333333 0 + 0.733333 0.333333 0 0.766667 0.333333 0 0.8 0.333333 0 0.833333 0.333333 0 + 0.866667 0.333333 0 0.9 0.333333 0 0.933333 0.333333 0 0.966667 0.333333 0 + 1 0.333333 0 0 0.366667 0 0.0333333 0.366667 0 0.0666667 0.366667 0 + 0.1 0.366667 0 0.133333 0.366667 0 0.166667 0.366667 0 0.2 0.366667 0 + 0.233333 0.366667 0 0.266667 0.366667 0 0.3 0.366667 0 0.333333 0.366667 0 + 0.366667 0.366667 0 0.4 0.366667 0 0.433333 0.366667 0 0.466667 0.366667 0 + 0.5 0.366667 0 0.533333 0.366667 0 0.566667 0.366667 0 0.6 0.366667 0 + 0.633333 0.366667 0 0.666667 0.366667 0 0.7 0.366667 0 0.733333 0.366667 0 + 0.766667 0.366667 0 0.8 0.366667 0 0.833333 0.366667 0 0.866667 0.366667 0 + 0.9 0.366667 0 0.933333 0.366667 0 0.966667 0.366667 0 1 0.366667 0 + 0 0.4 0 0.0333333 0.4 0 0.0666667 0.4 0 0.1 0.4 0 + 0.133333 0.4 0 0.166667 0.4 0 0.2 0.4 0 0.233333 0.4 0 + 0.266667 0.4 0 0.3 0.4 0 0.333333 0.4 0 0.366667 0.4 0 + 0.4 0.4 0 0.433333 0.4 0 0.466667 0.4 0 0.5 0.4 0 + 0.533333 0.4 0 0.566667 0.4 0 0.6 0.4 0 0.633333 0.4 0 + 0.666667 0.4 0 0.7 0.4 0 0.733333 0.4 0 0.766667 0.4 0 + 0.8 0.4 0 0.833333 0.4 0 0.866667 0.4 0 0.9 0.4 0 + 0.933333 0.4 0 0.966667 0.4 0 1 0.4 0 0 0.433333 0 + 0.0333333 0.433333 0 0.0666667 0.433333 0 0.1 0.433333 0 0.133333 0.433333 0 + 0.166667 0.433333 0 0.2 0.433333 0 0.233333 0.433333 0 0.266667 0.433333 0 + 0.3 0.433333 0 0.333333 0.433333 0 0.366667 0.433333 0 0.4 0.433333 0 + 0.433333 0.433333 0 0.466667 0.433333 0 0.5 0.433333 0 0.533333 0.433333 0 + 0.566667 0.433333 0 0.6 0.433333 0 0.633333 0.433333 0 0.666667 0.433333 0 + 0.7 0.433333 0 0.733333 0.433333 0 0.766667 0.433333 0 0.8 0.433333 0 + 0.833333 0.433333 0 0.866667 0.433333 0 0.9 0.433333 0 0.933333 0.433333 0 + 0.966667 0.433333 0 1 0.433333 0 0 0.466667 0 0.0333333 0.466667 0 + 0.0666667 0.466667 0 0.1 0.466667 0 0.133333 0.466667 0 0.166667 0.466667 0 + 0.2 0.466667 0 0.233333 0.466667 0 0.266667 0.466667 0 0.3 0.466667 0 + 0.333333 0.466667 0 0.366667 0.466667 0 0.4 0.466667 0 0.433333 0.466667 0 + 0.466667 0.466667 0 0.5 0.466667 0 0.533333 0.466667 0 0.566667 0.466667 0 + 0.6 0.466667 0 0.633333 0.466667 0 0.666667 0.466667 0 0.7 0.466667 0 + 0.733333 0.466667 0 0.766667 0.466667 0 0.8 0.466667 0 0.833333 0.466667 0 + 0.866667 0.466667 0 0.9 0.466667 0 0.933333 0.466667 0 0.966667 0.466667 0 + 1 0.466667 0 0 0.5 0 0.0333333 0.5 0 0.0666667 0.5 0 + 0.1 0.5 0 0.133333 0.5 0 0.166667 0.5 0 0.2 0.5 0 + 0.233333 0.5 0 0.266667 0.5 0 0.3 0.5 0 0.333333 0.5 0 + 0.366667 0.5 0 0.4 0.5 0 0.433333 0.5 0 0.466667 0.5 0 + 0.5 0.5 0 0.533333 0.5 0 0.566667 0.5 0 0.6 0.5 0 + 0.633333 0.5 0 0.666667 0.5 0 0.7 0.5 0 0.733333 0.5 0 + 0.766667 0.5 0 0.8 0.5 0 0.833333 0.5 0 0.866667 0.5 0 + 0.9 0.5 0 0.933333 0.5 0 0.966667 0.5 0 1 0.5 0 + 0 0.533333 0 0.0333333 0.533333 0 0.0666667 0.533333 0 0.1 0.533333 0 + 0.133333 0.533333 0 0.166667 0.533333 0 0.2 0.533333 0 0.233333 0.533333 0 + 0.266667 0.533333 0 0.3 0.533333 0 0.333333 0.533333 0 0.366667 0.533333 0 + 0.4 0.533333 0 0.433333 0.533333 0 0.466667 0.533333 0 0.5 0.533333 0 + 0.533333 0.533333 0 0.566667 0.533333 0 0.6 0.533333 0 0.633333 0.533333 0 + 0.666667 0.533333 0 0.7 0.533333 0 0.733333 0.533333 0 0.766667 0.533333 0 + 0.8 0.533333 0 0.833333 0.533333 0 0.866667 0.533333 0 0.9 0.533333 0 + 0.933333 0.533333 0 0.966667 0.533333 0 1 0.533333 0 0 0.566667 0 + 0.0333333 0.566667 0 0.0666667 0.566667 0 0.1 0.566667 0 0.133333 0.566667 0 + 0.166667 0.566667 0 0.2 0.566667 0 0.233333 0.566667 0 0.266667 0.566667 0 + 0.3 0.566667 0 0.333333 0.566667 0 0.366667 0.566667 0 0.4 0.566667 0 + 0.433333 0.566667 0 0.466667 0.566667 0 0.5 0.566667 0 0.533333 0.566667 0 + 0.566667 0.566667 0 0.6 0.566667 0 0.633333 0.566667 0 0.666667 0.566667 0 + 0.7 0.566667 0 0.733333 0.566667 0 0.766667 0.566667 0 0.8 0.566667 0 + 0.833333 0.566667 0 0.866667 0.566667 0 0.9 0.566667 0 0.933333 0.566667 0 + 0.966667 0.566667 0 1 0.566667 0 0 0.6 0 0.0333333 0.6 0 + 0.0666667 0.6 0 0.1 0.6 0 0.133333 0.6 0 0.166667 0.6 0 + 0.2 0.6 0 0.233333 0.6 0 0.266667 0.6 0 0.3 0.6 0 + 0.333333 0.6 0 0.366667 0.6 0 0.4 0.6 0 0.433333 0.6 0 + 0.466667 0.6 0 0.5 0.6 0 0.533333 0.6 0 0.566667 0.6 0 + 0.6 0.6 0 0.633333 0.6 0 0.666667 0.6 0 0.7 0.6 0 + 0.733333 0.6 0 0.766667 0.6 0 0.8 0.6 0 0.833333 0.6 0 + 0.866667 0.6 0 0.9 0.6 0 0.933333 0.6 0 0.966667 0.6 0 + 1 0.6 0 0 0.633333 0 0.0333333 0.633333 0 0.0666667 0.633333 0 + 0.1 0.633333 0 0.133333 0.633333 0 0.166667 0.633333 0 0.2 0.633333 0 + 0.233333 0.633333 0 0.266667 0.633333 0 0.3 0.633333 0 0.333333 0.633333 0 + 0.366667 0.633333 0 0.4 0.633333 0 0.433333 0.633333 0 0.466667 0.633333 0 + 0.5 0.633333 0 0.533333 0.633333 0 0.566667 0.633333 0 0.6 0.633333 0 + 0.633333 0.633333 0 0.666667 0.633333 0 0.7 0.633333 0 0.733333 0.633333 0 + 0.766667 0.633333 0 0.8 0.633333 0 0.833333 0.633333 0 0.866667 0.633333 0 + 0.9 0.633333 0 0.933333 0.633333 0 0.966667 0.633333 0 1 0.633333 0 + 0 0.666667 0 0.0333333 0.666667 0 0.0666667 0.666667 0 0.1 0.666667 0 + 0.133333 0.666667 0 0.166667 0.666667 0 0.2 0.666667 0 0.233333 0.666667 0 + 0.266667 0.666667 0 0.3 0.666667 0 0.333333 0.666667 0 0.366667 0.666667 0 + 0.4 0.666667 0 0.433333 0.666667 0 0.466667 0.666667 0 0.5 0.666667 0 + 0.533333 0.666667 0 0.566667 0.666667 0 0.6 0.666667 0 0.633333 0.666667 0 + 0.666667 0.666667 0 0.7 0.666667 0 0.733333 0.666667 0 0.766667 0.666667 0 + 0.8 0.666667 0 0.833333 0.666667 0 0.866667 0.666667 0 0.9 0.666667 0 + 0.933333 0.666667 0 0.966667 0.666667 0 1 0.666667 0 0 0.7 0 + 0.0333333 0.7 0 0.0666667 0.7 0 0.1 0.7 0 0.133333 0.7 0 + 0.166667 0.7 0 0.2 0.7 0 0.233333 0.7 0 0.266667 0.7 0 + 0.3 0.7 0 0.333333 0.7 0 0.366667 0.7 0 0.4 0.7 0 + 0.433333 0.7 0 0.466667 0.7 0 0.5 0.7 0 0.533333 0.7 0 + 0.566667 0.7 0 0.6 0.7 0 0.633333 0.7 0 0.666667 0.7 0 + 0.7 0.7 0 0.733333 0.7 0 0.766667 0.7 0 0.8 0.7 0 + 0.833333 0.7 0 0.866667 0.7 0 0.9 0.7 0 0.933333 0.7 0 + 0.966667 0.7 0 1 0.7 0 0 0.733333 0 0.0333333 0.733333 0 + 0.0666667 0.733333 0 0.1 0.733333 0 0.133333 0.733333 0 0.166667 0.733333 0 + 0.2 0.733333 0 0.233333 0.733333 0 0.266667 0.733333 0 0.3 0.733333 0 + 0.333333 0.733333 0 0.366667 0.733333 0 0.4 0.733333 0 0.433333 0.733333 0 + 0.466667 0.733333 0 0.5 0.733333 0 0.533333 0.733333 0 0.566667 0.733333 0 + 0.6 0.733333 0 0.633333 0.733333 0 0.666667 0.733333 0 0.7 0.733333 0 + 0.733333 0.733333 0 0.766667 0.733333 0 0.8 0.733333 0 0.833333 0.733333 0 + 0.866667 0.733333 0 0.9 0.733333 0 0.933333 0.733333 0 0.966667 0.733333 0 + 1 0.733333 0 0 0.766667 0 0.0333333 0.766667 0 0.0666667 0.766667 0 + 0.1 0.766667 0 0.133333 0.766667 0 0.166667 0.766667 0 0.2 0.766667 0 + 0.233333 0.766667 0 0.266667 0.766667 0 0.3 0.766667 0 0.333333 0.766667 0 + 0.366667 0.766667 0 0.4 0.766667 0 0.433333 0.766667 0 0.466667 0.766667 0 + 0.5 0.766667 0 0.533333 0.766667 0 0.566667 0.766667 0 0.6 0.766667 0 + 0.633333 0.766667 0 0.666667 0.766667 0 0.7 0.766667 0 0.733333 0.766667 0 + 0.766667 0.766667 0 0.8 0.766667 0 0.833333 0.766667 0 0.866667 0.766667 0 + 0.9 0.766667 0 0.933333 0.766667 0 0.966667 0.766667 0 1 0.766667 0 + 0 0.8 0 0.0333333 0.8 0 0.0666667 0.8 0 0.1 0.8 0 + 0.133333 0.8 0 0.166667 0.8 0 0.2 0.8 0 0.233333 0.8 0 + 0.266667 0.8 0 0.3 0.8 0 0.333333 0.8 0 0.366667 0.8 0 + 0.4 0.8 0 0.433333 0.8 0 0.466667 0.8 0 0.5 0.8 0 + 0.533333 0.8 0 0.566667 0.8 0 0.6 0.8 0 0.633333 0.8 0 + 0.666667 0.8 0 0.7 0.8 0 0.733333 0.8 0 0.766667 0.8 0 + 0.8 0.8 0 0.833333 0.8 0 0.866667 0.8 0 0.9 0.8 0 + 0.933333 0.8 0 0.966667 0.8 0 1 0.8 0 0 0.833333 0 + 0.0333333 0.833333 0 0.0666667 0.833333 0 0.1 0.833333 0 0.133333 0.833333 0 + 0.166667 0.833333 0 0.2 0.833333 0 0.233333 0.833333 0 0.266667 0.833333 0 + 0.3 0.833333 0 0.333333 0.833333 0 0.366667 0.833333 0 0.4 0.833333 0 + 0.433333 0.833333 0 0.466667 0.833333 0 0.5 0.833333 0 0.533333 0.833333 0 + 0.566667 0.833333 0 0.6 0.833333 0 0.633333 0.833333 0 0.666667 0.833333 0 + 0.7 0.833333 0 0.733333 0.833333 0 0.766667 0.833333 0 0.8 0.833333 0 + 0.833333 0.833333 0 0.866667 0.833333 0 0.9 0.833333 0 0.933333 0.833333 0 + 0.966667 0.833333 0 1 0.833333 0 0 0.866667 0 0.0333333 0.866667 0 + 0.0666667 0.866667 0 0.1 0.866667 0 0.133333 0.866667 0 0.166667 0.866667 0 + 0.2 0.866667 0 0.233333 0.866667 0 0.266667 0.866667 0 0.3 0.866667 0 + 0.333333 0.866667 0 0.366667 0.866667 0 0.4 0.866667 0 0.433333 0.866667 0 + 0.466667 0.866667 0 0.5 0.866667 0 0.533333 0.866667 0 0.566667 0.866667 0 + 0.6 0.866667 0 0.633333 0.866667 0 0.666667 0.866667 0 0.7 0.866667 0 + 0.733333 0.866667 0 0.766667 0.866667 0 0.8 0.866667 0 0.833333 0.866667 0 + 0.866667 0.866667 0 0.9 0.866667 0 0.933333 0.866667 0 0.966667 0.866667 0 + 1 0.866667 0 0 0.9 0 0.0333333 0.9 0 0.0666667 0.9 0 + 0.1 0.9 0 0.133333 0.9 0 0.166667 0.9 0 0.2 0.9 0 + 0.233333 0.9 0 0.266667 0.9 0 0.3 0.9 0 0.333333 0.9 0 + 0.366667 0.9 0 0.4 0.9 0 0.433333 0.9 0 0.466667 0.9 0 + 0.5 0.9 0 0.533333 0.9 0 0.566667 0.9 0 0.6 0.9 0 + 0.633333 0.9 0 0.666667 0.9 0 0.7 0.9 0 0.733333 0.9 0 + 0.766667 0.9 0 0.8 0.9 0 0.833333 0.9 0 0.866667 0.9 0 + 0.9 0.9 0 0.933333 0.9 0 0.966667 0.9 0 1 0.9 0 + 0 0.933333 0 0.0333333 0.933333 0 0.0666667 0.933333 0 0.1 0.933333 0 + 0.133333 0.933333 0 0.166667 0.933333 0 0.2 0.933333 0 0.233333 0.933333 0 + 0.266667 0.933333 0 0.3 0.933333 0 0.333333 0.933333 0 0.366667 0.933333 0 + 0.4 0.933333 0 0.433333 0.933333 0 0.466667 0.933333 0 0.5 0.933333 0 + 0.533333 0.933333 0 0.566667 0.933333 0 0.6 0.933333 0 0.633333 0.933333 0 + 0.666667 0.933333 0 0.7 0.933333 0 0.733333 0.933333 0 0.766667 0.933333 0 + 0.8 0.933333 0 0.833333 0.933333 0 0.866667 0.933333 0 0.9 0.933333 0 + 0.933333 0.933333 0 0.966667 0.933333 0 1 0.933333 0 0 0.966667 0 + 0.0333333 0.966667 0 0.0666667 0.966667 0 0.1 0.966667 0 0.133333 0.966667 0 + 0.166667 0.966667 0 0.2 0.966667 0 0.233333 0.966667 0 0.266667 0.966667 0 + 0.3 0.966667 0 0.333333 0.966667 0 0.366667 0.966667 0 0.4 0.966667 0 + 0.433333 0.966667 0 0.466667 0.966667 0 0.5 0.966667 0 0.533333 0.966667 0 + 0.566667 0.966667 0 0.6 0.966667 0 0.633333 0.966667 0 0.666667 0.966667 0 + 0.7 0.966667 0 0.733333 0.966667 0 0.766667 0.966667 0 0.8 0.966667 0 + 0.833333 0.966667 0 0.866667 0.966667 0 0.9 0.966667 0 0.933333 0.966667 0 + 0.966667 0.966667 0 1 0.966667 0 0 1 0 0.0333333 1 0 + 0.0666667 1 0 0.1 1 0 0.133333 1 0 0.166667 1 0 + 0.2 1 0 0.233333 1 0 0.266667 1 0 0.3 1 0 + 0.333333 1 0 0.366667 1 0 0.4 1 0 0.433333 1 0 + 0.466667 1 0 0.5 1 0 0.533333 1 0 0.566667 1 0 + 0.6 1 0 0.633333 1 0 0.666667 1 0 0.7 1 0 + 0.733333 1 0 0.766667 1 0 0.8 1 0 0.833333 1 0 + 0.866667 1 0 0.9 1 0 0.933333 1 0 0.966667 1 0 + 1 1 0 + + + + + 0 1 3 2 1 4 5 3 4 6 7 5 + 6 8 9 7 8 10 11 9 10 12 13 11 + 12 14 15 13 14 16 17 15 16 18 19 17 + 18 20 21 19 20 22 23 21 22 24 25 23 + 24 26 27 25 26 28 29 27 28 30 31 29 + 30 32 33 31 32 34 35 33 34 36 37 35 + 36 38 39 37 38 40 41 39 40 42 43 41 + 42 44 45 43 44 46 47 45 46 48 49 47 + 48 50 51 49 50 52 53 51 52 54 55 53 + 54 56 57 55 56 58 59 57 58 60 61 59 + 2 3 63 62 3 5 64 63 5 7 65 64 + 7 9 66 65 9 11 67 66 11 13 68 67 + 13 15 69 68 15 17 70 69 17 19 71 70 + 19 21 72 71 21 23 73 72 23 25 74 73 + 25 27 75 74 27 29 76 75 29 31 77 76 + 31 33 78 77 33 35 79 78 35 37 80 79 + 37 39 81 80 39 41 82 81 41 43 83 82 + 43 45 84 83 45 47 85 84 47 49 86 85 + 49 51 87 86 51 53 88 87 53 55 89 88 + 55 57 90 89 57 59 91 90 59 61 92 91 + 62 63 94 93 63 64 95 94 64 65 96 95 + 65 66 97 96 66 67 98 97 67 68 99 98 + 68 69 100 99 69 70 101 100 70 71 102 101 + 71 72 103 102 72 73 104 103 73 74 105 104 + 74 75 106 105 75 76 107 106 76 77 108 107 + 77 78 109 108 78 79 110 109 79 80 111 110 + 80 81 112 111 81 82 113 112 82 83 114 113 + 83 84 115 114 84 85 116 115 85 86 117 116 + 86 87 118 117 87 88 119 118 88 89 120 119 + 89 90 121 120 90 91 122 121 91 92 123 122 + 93 94 125 124 94 95 126 125 95 96 127 126 + 96 97 128 127 97 98 129 128 98 99 130 129 + 99 100 131 130 100 101 132 131 101 102 133 132 + 102 103 134 133 103 104 135 134 104 105 136 135 + 105 106 137 136 106 107 138 137 107 108 139 138 + 108 109 140 139 109 110 141 140 110 111 142 141 + 111 112 143 142 112 113 144 143 113 114 145 144 + 114 115 146 145 115 116 147 146 116 117 148 147 + 117 118 149 148 118 119 150 149 119 120 151 150 + 120 121 152 151 121 122 153 152 122 123 154 153 + 124 125 156 155 125 126 157 156 126 127 158 157 + 127 128 159 158 128 129 160 159 129 130 161 160 + 130 131 162 161 131 132 163 162 132 133 164 163 + 133 134 165 164 134 135 166 165 135 136 167 166 + 136 137 168 167 137 138 169 168 138 139 170 169 + 139 140 171 170 140 141 172 171 141 142 173 172 + 142 143 174 173 143 144 175 174 144 145 176 175 + 145 146 177 176 146 147 178 177 147 148 179 178 + 148 149 180 179 149 150 181 180 150 151 182 181 + 151 152 183 182 152 153 184 183 153 154 185 184 + 155 156 187 186 156 157 188 187 157 158 189 188 + 158 159 190 189 159 160 191 190 160 161 192 191 + 161 162 193 192 162 163 194 193 163 164 195 194 + 164 165 196 195 165 166 197 196 166 167 198 197 + 167 168 199 198 168 169 200 199 169 170 201 200 + 170 171 202 201 171 172 203 202 172 173 204 203 + 173 174 205 204 174 175 206 205 175 176 207 206 + 176 177 208 207 177 178 209 208 178 179 210 209 + 179 180 211 210 180 181 212 211 181 182 213 212 + 182 183 214 213 183 184 215 214 184 185 216 215 + 186 187 218 217 187 188 219 218 188 189 220 219 + 189 190 221 220 190 191 222 221 191 192 223 222 + 192 193 224 223 193 194 225 224 194 195 226 225 + 195 196 227 226 196 197 228 227 197 198 229 228 + 198 199 230 229 199 200 231 230 200 201 232 231 + 201 202 233 232 202 203 234 233 203 204 235 234 + 204 205 236 235 205 206 237 236 206 207 238 237 + 207 208 239 238 208 209 240 239 209 210 241 240 + 210 211 242 241 211 212 243 242 212 213 244 243 + 213 214 245 244 214 215 246 245 215 216 247 246 + 217 218 249 248 218 219 250 249 219 220 251 250 + 220 221 252 251 221 222 253 252 222 223 254 253 + 223 224 255 254 224 225 256 255 225 226 257 256 + 226 227 258 257 227 228 259 258 228 229 260 259 + 229 230 261 260 230 231 262 261 231 232 263 262 + 232 233 264 263 233 234 265 264 234 235 266 265 + 235 236 267 266 236 237 268 267 237 238 269 268 + 238 239 270 269 239 240 271 270 240 241 272 271 + 241 242 273 272 242 243 274 273 243 244 275 274 + 244 245 276 275 245 246 277 276 246 247 278 277 + 248 249 280 279 249 250 281 280 250 251 282 281 + 251 252 283 282 252 253 284 283 253 254 285 284 + 254 255 286 285 255 256 287 286 256 257 288 287 + 257 258 289 288 258 259 290 289 259 260 291 290 + 260 261 292 291 261 262 293 292 262 263 294 293 + 263 264 295 294 264 265 296 295 265 266 297 296 + 266 267 298 297 267 268 299 298 268 269 300 299 + 269 270 301 300 270 271 302 301 271 272 303 302 + 272 273 304 303 273 274 305 304 274 275 306 305 + 275 276 307 306 276 277 308 307 277 278 309 308 + 279 280 311 310 280 281 312 311 281 282 313 312 + 282 283 314 313 283 284 315 314 284 285 316 315 + 285 286 317 316 286 287 318 317 287 288 319 318 + 288 289 320 319 289 290 321 320 290 291 322 321 + 291 292 323 322 292 293 324 323 293 294 325 324 + 294 295 326 325 295 296 327 326 296 297 328 327 + 297 298 329 328 298 299 330 329 299 300 331 330 + 300 301 332 331 301 302 333 332 302 303 334 333 + 303 304 335 334 304 305 336 335 305 306 337 336 + 306 307 338 337 307 308 339 338 308 309 340 339 + 310 311 342 341 311 312 343 342 312 313 344 343 + 313 314 345 344 314 315 346 345 315 316 347 346 + 316 317 348 347 317 318 349 348 318 319 350 349 + 319 320 351 350 320 321 352 351 321 322 353 352 + 322 323 354 353 323 324 355 354 324 325 356 355 + 325 326 357 356 326 327 358 357 327 328 359 358 + 328 329 360 359 329 330 361 360 330 331 362 361 + 331 332 363 362 332 333 364 363 333 334 365 364 + 334 335 366 365 335 336 367 366 336 337 368 367 + 337 338 369 368 338 339 370 369 339 340 371 370 + 341 342 373 372 342 343 374 373 343 344 375 374 + 344 345 376 375 345 346 377 376 346 347 378 377 + 347 348 379 378 348 349 380 379 349 350 381 380 + 350 351 382 381 351 352 383 382 352 353 384 383 + 353 354 385 384 354 355 386 385 355 356 387 386 + 356 357 388 387 357 358 389 388 358 359 390 389 + 359 360 391 390 360 361 392 391 361 362 393 392 + 362 363 394 393 363 364 395 394 364 365 396 395 + 365 366 397 396 366 367 398 397 367 368 399 398 + 368 369 400 399 369 370 401 400 370 371 402 401 + 372 373 404 403 373 374 405 404 374 375 406 405 + 375 376 407 406 376 377 408 407 377 378 409 408 + 378 379 410 409 379 380 411 410 380 381 412 411 + 381 382 413 412 382 383 414 413 383 384 415 414 + 384 385 416 415 385 386 417 416 386 387 418 417 + 387 388 419 418 388 389 420 419 389 390 421 420 + 390 391 422 421 391 392 423 422 392 393 424 423 + 393 394 425 424 394 395 426 425 395 396 427 426 + 396 397 428 427 397 398 429 428 398 399 430 429 + 399 400 431 430 400 401 432 431 401 402 433 432 + 403 404 435 434 404 405 436 435 405 406 437 436 + 406 407 438 437 407 408 439 438 408 409 440 439 + 409 410 441 440 410 411 442 441 411 412 443 442 + 412 413 444 443 413 414 445 444 414 415 446 445 + 415 416 447 446 416 417 448 447 417 418 449 448 + 418 419 450 449 419 420 451 450 420 421 452 451 + 421 422 453 452 422 423 454 453 423 424 455 454 + 424 425 456 455 425 426 457 456 426 427 458 457 + 427 428 459 458 428 429 460 459 429 430 461 460 + 430 431 462 461 431 432 463 462 432 433 464 463 + 434 435 466 465 435 436 467 466 436 437 468 467 + 437 438 469 468 438 439 470 469 439 440 471 470 + 440 441 472 471 441 442 473 472 442 443 474 473 + 443 444 475 474 444 445 476 475 445 446 477 476 + 446 447 478 477 447 448 479 478 448 449 480 479 + 449 450 481 480 450 451 482 481 451 452 483 482 + 452 453 484 483 453 454 485 484 454 455 486 485 + 455 456 487 486 456 457 488 487 457 458 489 488 + 458 459 490 489 459 460 491 490 460 461 492 491 + 461 462 493 492 462 463 494 493 463 464 495 494 + 465 466 497 496 466 467 498 497 467 468 499 498 + 468 469 500 499 469 470 501 500 470 471 502 501 + 471 472 503 502 472 473 504 503 473 474 505 504 + 474 475 506 505 475 476 507 506 476 477 508 507 + 477 478 509 508 478 479 510 509 479 480 511 510 + 480 481 512 511 481 482 513 512 482 483 514 513 + 483 484 515 514 484 485 516 515 485 486 517 516 + 486 487 518 517 487 488 519 518 488 489 520 519 + 489 490 521 520 490 491 522 521 491 492 523 522 + 492 493 524 523 493 494 525 524 494 495 526 525 + 496 497 528 527 497 498 529 528 498 499 530 529 + 499 500 531 530 500 501 532 531 501 502 533 532 + 502 503 534 533 503 504 535 534 504 505 536 535 + 505 506 537 536 506 507 538 537 507 508 539 538 + 508 509 540 539 509 510 541 540 510 511 542 541 + 511 512 543 542 512 513 544 543 513 514 545 544 + 514 515 546 545 515 516 547 546 516 517 548 547 + 517 518 549 548 518 519 550 549 519 520 551 550 + 520 521 552 551 521 522 553 552 522 523 554 553 + 523 524 555 554 524 525 556 555 525 526 557 556 + 527 528 559 558 528 529 560 559 529 530 561 560 + 530 531 562 561 531 532 563 562 532 533 564 563 + 533 534 565 564 534 535 566 565 535 536 567 566 + 536 537 568 567 537 538 569 568 538 539 570 569 + 539 540 571 570 540 541 572 571 541 542 573 572 + 542 543 574 573 543 544 575 574 544 545 576 575 + 545 546 577 576 546 547 578 577 547 548 579 578 + 548 549 580 579 549 550 581 580 550 551 582 581 + 551 552 583 582 552 553 584 583 553 554 585 584 + 554 555 586 585 555 556 587 586 556 557 588 587 + 558 559 590 589 559 560 591 590 560 561 592 591 + 561 562 593 592 562 563 594 593 563 564 595 594 + 564 565 596 595 565 566 597 596 566 567 598 597 + 567 568 599 598 568 569 600 599 569 570 601 600 + 570 571 602 601 571 572 603 602 572 573 604 603 + 573 574 605 604 574 575 606 605 575 576 607 606 + 576 577 608 607 577 578 609 608 578 579 610 609 + 579 580 611 610 580 581 612 611 581 582 613 612 + 582 583 614 613 583 584 615 614 584 585 616 615 + 585 586 617 616 586 587 618 617 587 588 619 618 + 589 590 621 620 590 591 622 621 591 592 623 622 + 592 593 624 623 593 594 625 624 594 595 626 625 + 595 596 627 626 596 597 628 627 597 598 629 628 + 598 599 630 629 599 600 631 630 600 601 632 631 + 601 602 633 632 602 603 634 633 603 604 635 634 + 604 605 636 635 605 606 637 636 606 607 638 637 + 607 608 639 638 608 609 640 639 609 610 641 640 + 610 611 642 641 611 612 643 642 612 613 644 643 + 613 614 645 644 614 615 646 645 615 616 647 646 + 616 617 648 647 617 618 649 648 618 619 650 649 + 620 621 652 651 621 622 653 652 622 623 654 653 + 623 624 655 654 624 625 656 655 625 626 657 656 + 626 627 658 657 627 628 659 658 628 629 660 659 + 629 630 661 660 630 631 662 661 631 632 663 662 + 632 633 664 663 633 634 665 664 634 635 666 665 + 635 636 667 666 636 637 668 667 637 638 669 668 + 638 639 670 669 639 640 671 670 640 641 672 671 + 641 642 673 672 642 643 674 673 643 644 675 674 + 644 645 676 675 645 646 677 676 646 647 678 677 + 647 648 679 678 648 649 680 679 649 650 681 680 + 651 652 683 682 652 653 684 683 653 654 685 684 + 654 655 686 685 655 656 687 686 656 657 688 687 + 657 658 689 688 658 659 690 689 659 660 691 690 + 660 661 692 691 661 662 693 692 662 663 694 693 + 663 664 695 694 664 665 696 695 665 666 697 696 + 666 667 698 697 667 668 699 698 668 669 700 699 + 669 670 701 700 670 671 702 701 671 672 703 702 + 672 673 704 703 673 674 705 704 674 675 706 705 + 675 676 707 706 676 677 708 707 677 678 709 708 + 678 679 710 709 679 680 711 710 680 681 712 711 + 682 683 714 713 683 684 715 714 684 685 716 715 + 685 686 717 716 686 687 718 717 687 688 719 718 + 688 689 720 719 689 690 721 720 690 691 722 721 + 691 692 723 722 692 693 724 723 693 694 725 724 + 694 695 726 725 695 696 727 726 696 697 728 727 + 697 698 729 728 698 699 730 729 699 700 731 730 + 700 701 732 731 701 702 733 732 702 703 734 733 + 703 704 735 734 704 705 736 735 705 706 737 736 + 706 707 738 737 707 708 739 738 708 709 740 739 + 709 710 741 740 710 711 742 741 711 712 743 742 + 713 714 745 744 714 715 746 745 715 716 747 746 + 716 717 748 747 717 718 749 748 718 719 750 749 + 719 720 751 750 720 721 752 751 721 722 753 752 + 722 723 754 753 723 724 755 754 724 725 756 755 + 725 726 757 756 726 727 758 757 727 728 759 758 + 728 729 760 759 729 730 761 760 730 731 762 761 + 731 732 763 762 732 733 764 763 733 734 765 764 + 734 735 766 765 735 736 767 766 736 737 768 767 + 737 738 769 768 738 739 770 769 739 740 771 770 + 740 741 772 771 741 742 773 772 742 743 774 773 + 744 745 776 775 745 746 777 776 746 747 778 777 + 747 748 779 778 748 749 780 779 749 750 781 780 + 750 751 782 781 751 752 783 782 752 753 784 783 + 753 754 785 784 754 755 786 785 755 756 787 786 + 756 757 788 787 757 758 789 788 758 759 790 789 + 759 760 791 790 760 761 792 791 761 762 793 792 + 762 763 794 793 763 764 795 794 764 765 796 795 + 765 766 797 796 766 767 798 797 767 768 799 798 + 768 769 800 799 769 770 801 800 770 771 802 801 + 771 772 803 802 772 773 804 803 773 774 805 804 + 775 776 807 806 776 777 808 807 777 778 809 808 + 778 779 810 809 779 780 811 810 780 781 812 811 + 781 782 813 812 782 783 814 813 783 784 815 814 + 784 785 816 815 785 786 817 816 786 787 818 817 + 787 788 819 818 788 789 820 819 789 790 821 820 + 790 791 822 821 791 792 823 822 792 793 824 823 + 793 794 825 824 794 795 826 825 795 796 827 826 + 796 797 828 827 797 798 829 828 798 799 830 829 + 799 800 831 830 800 801 832 831 801 802 833 832 + 802 803 834 833 803 804 835 834 804 805 836 835 + 806 807 838 837 807 808 839 838 808 809 840 839 + 809 810 841 840 810 811 842 841 811 812 843 842 + 812 813 844 843 813 814 845 844 814 815 846 845 + 815 816 847 846 816 817 848 847 817 818 849 848 + 818 819 850 849 819 820 851 850 820 821 852 851 + 821 822 853 852 822 823 854 853 823 824 855 854 + 824 825 856 855 825 826 857 856 826 827 858 857 + 827 828 859 858 828 829 860 859 829 830 861 860 + 830 831 862 861 831 832 863 862 832 833 864 863 + 833 834 865 864 834 835 866 865 835 836 867 866 + 837 838 869 868 838 839 870 869 839 840 871 870 + 840 841 872 871 841 842 873 872 842 843 874 873 + 843 844 875 874 844 845 876 875 845 846 877 876 + 846 847 878 877 847 848 879 878 848 849 880 879 + 849 850 881 880 850 851 882 881 851 852 883 882 + 852 853 884 883 853 854 885 884 854 855 886 885 + 855 856 887 886 856 857 888 887 857 858 889 888 + 858 859 890 889 859 860 891 890 860 861 892 891 + 861 862 893 892 862 863 894 893 863 864 895 894 + 864 865 896 895 865 866 897 896 866 867 898 897 + 868 869 900 899 869 870 901 900 870 871 902 901 + 871 872 903 902 872 873 904 903 873 874 905 904 + 874 875 906 905 875 876 907 906 876 877 908 907 + 877 878 909 908 878 879 910 909 879 880 911 910 + 880 881 912 911 881 882 913 912 882 883 914 913 + 883 884 915 914 884 885 916 915 885 886 917 916 + 886 887 918 917 887 888 919 918 888 889 920 919 + 889 890 921 920 890 891 922 921 891 892 923 922 + 892 893 924 923 893 894 925 924 894 895 926 925 + 895 896 927 926 896 897 928 927 897 898 929 928 + 899 900 931 930 900 901 932 931 901 902 933 932 + 902 903 934 933 903 904 935 934 904 905 936 935 + 905 906 937 936 906 907 938 937 907 908 939 938 + 908 909 940 939 909 910 941 940 910 911 942 941 + 911 912 943 942 912 913 944 943 913 914 945 944 + 914 915 946 945 915 916 947 946 916 917 948 947 + 917 918 949 948 918 919 950 949 919 920 951 950 + 920 921 952 951 921 922 953 952 922 923 954 953 + 923 924 955 954 924 925 956 955 925 926 957 956 + 926 927 958 957 927 928 959 958 928 929 960 959 + + + 4 8 12 16 20 24 28 32 36 40 44 48 + 52 56 60 64 68 72 76 80 84 88 92 96 + 100 104 108 112 116 120 124 128 132 136 140 144 + 148 152 156 160 164 168 172 176 180 184 188 192 + 196 200 204 208 212 216 220 224 228 232 236 240 + 244 248 252 256 260 264 268 272 276 280 284 288 + 292 296 300 304 308 312 316 320 324 328 332 336 + 340 344 348 352 356 360 364 368 372 376 380 384 + 388 392 396 400 404 408 412 416 420 424 428 432 + 436 440 444 448 452 456 460 464 468 472 476 480 + 484 488 492 496 500 504 508 512 516 520 524 528 + 532 536 540 544 548 552 556 560 564 568 572 576 + 580 584 588 592 596 600 604 608 612 616 620 624 + 628 632 636 640 644 648 652 656 660 664 668 672 + 676 680 684 688 692 696 700 704 708 712 716 720 + 724 728 732 736 740 744 748 752 756 760 764 768 + 772 776 780 784 788 792 796 800 804 808 812 816 + 820 824 828 832 836 840 844 848 852 856 860 864 + 868 872 876 880 884 888 892 896 900 904 908 912 + 916 920 924 928 932 936 940 944 948 952 956 960 + 964 968 972 976 980 984 988 992 996 1000 1004 1008 + 1012 1016 1020 1024 1028 1032 1036 1040 1044 1048 1052 1056 + 1060 1064 1068 1072 1076 1080 1084 1088 1092 1096 1100 1104 + 1108 1112 1116 1120 1124 1128 1132 1136 1140 1144 1148 1152 + 1156 1160 1164 1168 1172 1176 1180 1184 1188 1192 1196 1200 + 1204 1208 1212 1216 1220 1224 1228 1232 1236 1240 1244 1248 + 1252 1256 1260 1264 1268 1272 1276 1280 1284 1288 1292 1296 + 1300 1304 1308 1312 1316 1320 1324 1328 1332 1336 1340 1344 + 1348 1352 1356 1360 1364 1368 1372 1376 1380 1384 1388 1392 + 1396 1400 1404 1408 1412 1416 1420 1424 1428 1432 1436 1440 + 1444 1448 1452 1456 1460 1464 1468 1472 1476 1480 1484 1488 + 1492 1496 1500 1504 1508 1512 1516 1520 1524 1528 1532 1536 + 1540 1544 1548 1552 1556 1560 1564 1568 1572 1576 1580 1584 + 1588 1592 1596 1600 1604 1608 1612 1616 1620 1624 1628 1632 + 1636 1640 1644 1648 1652 1656 1660 1664 1668 1672 1676 1680 + 1684 1688 1692 1696 1700 1704 1708 1712 1716 1720 1724 1728 + 1732 1736 1740 1744 1748 1752 1756 1760 1764 1768 1772 1776 + 1780 1784 1788 1792 1796 1800 1804 1808 1812 1816 1820 1824 + 1828 1832 1836 1840 1844 1848 1852 1856 1860 1864 1868 1872 + 1876 1880 1884 1888 1892 1896 1900 1904 1908 1912 1916 1920 + 1924 1928 1932 1936 1940 1944 1948 1952 1956 1960 1964 1968 + 1972 1976 1980 1984 1988 1992 1996 2000 2004 2008 2012 2016 + 2020 2024 2028 2032 2036 2040 2044 2048 2052 2056 2060 2064 + 2068 2072 2076 2080 2084 2088 2092 2096 2100 2104 2108 2112 + 2116 2120 2124 2128 2132 2136 2140 2144 2148 2152 2156 2160 + 2164 2168 2172 2176 2180 2184 2188 2192 2196 2200 2204 2208 + 2212 2216 2220 2224 2228 2232 2236 2240 2244 2248 2252 2256 + 2260 2264 2268 2272 2276 2280 2284 2288 2292 2296 2300 2304 + 2308 2312 2316 2320 2324 2328 2332 2336 2340 2344 2348 2352 + 2356 2360 2364 2368 2372 2376 2380 2384 2388 2392 2396 2400 + 2404 2408 2412 2416 2420 2424 2428 2432 2436 2440 2444 2448 + 2452 2456 2460 2464 2468 2472 2476 2480 2484 2488 2492 2496 + 2500 2504 2508 2512 2516 2520 2524 2528 2532 2536 2540 2544 + 2548 2552 2556 2560 2564 2568 2572 2576 2580 2584 2588 2592 + 2596 2600 2604 2608 2612 2616 2620 2624 2628 2632 2636 2640 + 2644 2648 2652 2656 2660 2664 2668 2672 2676 2680 2684 2688 + 2692 2696 2700 2704 2708 2712 2716 2720 2724 2728 2732 2736 + 2740 2744 2748 2752 2756 2760 2764 2768 2772 2776 2780 2784 + 2788 2792 2796 2800 2804 2808 2812 2816 2820 2824 2828 2832 + 2836 2840 2844 2848 2852 2856 2860 2864 2868 2872 2876 2880 + 2884 2888 2892 2896 2900 2904 2908 2912 2916 2920 2924 2928 + 2932 2936 2940 2944 2948 2952 2956 2960 2964 2968 2972 2976 + 2980 2984 2988 2992 2996 3000 3004 3008 3012 3016 3020 3024 + 3028 3032 3036 3040 3044 3048 3052 3056 3060 3064 3068 3072 + 3076 3080 3084 3088 3092 3096 3100 3104 3108 3112 3116 3120 + 3124 3128 3132 3136 3140 3144 3148 3152 3156 3160 3164 3168 + 3172 3176 3180 3184 3188 3192 3196 3200 3204 3208 3212 3216 + 3220 3224 3228 3232 3236 3240 3244 3248 3252 3256 3260 3264 + 3268 3272 3276 3280 3284 3288 3292 3296 3300 3304 3308 3312 + 3316 3320 3324 3328 3332 3336 3340 3344 3348 3352 3356 3360 + 3364 3368 3372 3376 3380 3384 3388 3392 3396 3400 3404 3408 + 3412 3416 3420 3424 3428 3432 3436 3440 3444 3448 3452 3456 + 3460 3464 3468 3472 3476 3480 3484 3488 3492 3496 3500 3504 + 3508 3512 3516 3520 3524 3528 3532 3536 3540 3544 3548 3552 + 3556 3560 3564 3568 3572 3576 3580 3584 3588 3592 3596 3600 + + + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + + + + + diff --git a/test/references/maxwellstefanfreeflow-reference.vtu b/test/references/maxwellstefanfreeflow-reference.vtu new file mode 100644 index 0000000000000000000000000000000000000000..b4e0f09e170f50d7b44a5bd8bc9d7a6fb6ce6b72 --- /dev/null +++ b/test/references/maxwellstefanfreeflow-reference.vtu @@ -0,0 +1,1482 @@ + + + + + + + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 109996 + + + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 34.5304 + + + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + + + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + + + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 + 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 + 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250603 0.250603 0.250603 0.250603 0.250603 0.250603 + 0.250603 0.250604 0.250604 0.250604 0.250604 0.250604 0.250604 0.250605 0.250605 0.250605 0.250605 0.250606 + 0.250606 0.250606 0.250606 0.250606 0.250606 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 0.250607 + + + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + + + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 + 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 + 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 0.49972 0.499721 0.499724 0.499727 0.499732 0.499737 + 0.499744 0.499751 0.499759 0.499768 0.499777 0.499787 0.499798 0.499809 0.49982 0.49983 0.499841 0.499852 + 0.499863 0.499873 0.499882 0.499891 0.499899 0.499906 0.499913 0.499918 0.499923 0.499926 0.499929 0.49993 + + + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + + + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 + 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 + 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 0.249677 0.249676 0.249673 0.24967 0.249665 0.24966 + 0.249653 0.249646 0.249637 0.249628 0.249619 0.249608 0.249598 0.249587 0.249576 0.249564 0.249553 0.249542 + 0.249532 0.249521 0.249512 0.249503 0.249494 0.249487 0.24948 0.249475 0.24947 0.249467 0.249464 0.249463 + + + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + + + + + 0 0 0 0.0333333 0 0 0 0.0333333 0 0.0333333 0.0333333 0 + 0.0666667 0 0 0.0666667 0.0333333 0 0.1 0 0 0.1 0.0333333 0 + 0.133333 0 0 0.133333 0.0333333 0 0.166667 0 0 0.166667 0.0333333 0 + 0.2 0 0 0.2 0.0333333 0 0.233333 0 0 0.233333 0.0333333 0 + 0.266667 0 0 0.266667 0.0333333 0 0.3 0 0 0.3 0.0333333 0 + 0.333333 0 0 0.333333 0.0333333 0 0.366667 0 0 0.366667 0.0333333 0 + 0.4 0 0 0.4 0.0333333 0 0.433333 0 0 0.433333 0.0333333 0 + 0.466667 0 0 0.466667 0.0333333 0 0.5 0 0 0.5 0.0333333 0 + 0.533333 0 0 0.533333 0.0333333 0 0.566667 0 0 0.566667 0.0333333 0 + 0.6 0 0 0.6 0.0333333 0 0.633333 0 0 0.633333 0.0333333 0 + 0.666667 0 0 0.666667 0.0333333 0 0.7 0 0 0.7 0.0333333 0 + 0.733333 0 0 0.733333 0.0333333 0 0.766667 0 0 0.766667 0.0333333 0 + 0.8 0 0 0.8 0.0333333 0 0.833333 0 0 0.833333 0.0333333 0 + 0.866667 0 0 0.866667 0.0333333 0 0.9 0 0 0.9 0.0333333 0 + 0.933333 0 0 0.933333 0.0333333 0 0.966667 0 0 0.966667 0.0333333 0 + 1 0 0 1 0.0333333 0 0 0.0666667 0 0.0333333 0.0666667 0 + 0.0666667 0.0666667 0 0.1 0.0666667 0 0.133333 0.0666667 0 0.166667 0.0666667 0 + 0.2 0.0666667 0 0.233333 0.0666667 0 0.266667 0.0666667 0 0.3 0.0666667 0 + 0.333333 0.0666667 0 0.366667 0.0666667 0 0.4 0.0666667 0 0.433333 0.0666667 0 + 0.466667 0.0666667 0 0.5 0.0666667 0 0.533333 0.0666667 0 0.566667 0.0666667 0 + 0.6 0.0666667 0 0.633333 0.0666667 0 0.666667 0.0666667 0 0.7 0.0666667 0 + 0.733333 0.0666667 0 0.766667 0.0666667 0 0.8 0.0666667 0 0.833333 0.0666667 0 + 0.866667 0.0666667 0 0.9 0.0666667 0 0.933333 0.0666667 0 0.966667 0.0666667 0 + 1 0.0666667 0 0 0.1 0 0.0333333 0.1 0 0.0666667 0.1 0 + 0.1 0.1 0 0.133333 0.1 0 0.166667 0.1 0 0.2 0.1 0 + 0.233333 0.1 0 0.266667 0.1 0 0.3 0.1 0 0.333333 0.1 0 + 0.366667 0.1 0 0.4 0.1 0 0.433333 0.1 0 0.466667 0.1 0 + 0.5 0.1 0 0.533333 0.1 0 0.566667 0.1 0 0.6 0.1 0 + 0.633333 0.1 0 0.666667 0.1 0 0.7 0.1 0 0.733333 0.1 0 + 0.766667 0.1 0 0.8 0.1 0 0.833333 0.1 0 0.866667 0.1 0 + 0.9 0.1 0 0.933333 0.1 0 0.966667 0.1 0 1 0.1 0 + 0 0.133333 0 0.0333333 0.133333 0 0.0666667 0.133333 0 0.1 0.133333 0 + 0.133333 0.133333 0 0.166667 0.133333 0 0.2 0.133333 0 0.233333 0.133333 0 + 0.266667 0.133333 0 0.3 0.133333 0 0.333333 0.133333 0 0.366667 0.133333 0 + 0.4 0.133333 0 0.433333 0.133333 0 0.466667 0.133333 0 0.5 0.133333 0 + 0.533333 0.133333 0 0.566667 0.133333 0 0.6 0.133333 0 0.633333 0.133333 0 + 0.666667 0.133333 0 0.7 0.133333 0 0.733333 0.133333 0 0.766667 0.133333 0 + 0.8 0.133333 0 0.833333 0.133333 0 0.866667 0.133333 0 0.9 0.133333 0 + 0.933333 0.133333 0 0.966667 0.133333 0 1 0.133333 0 0 0.166667 0 + 0.0333333 0.166667 0 0.0666667 0.166667 0 0.1 0.166667 0 0.133333 0.166667 0 + 0.166667 0.166667 0 0.2 0.166667 0 0.233333 0.166667 0 0.266667 0.166667 0 + 0.3 0.166667 0 0.333333 0.166667 0 0.366667 0.166667 0 0.4 0.166667 0 + 0.433333 0.166667 0 0.466667 0.166667 0 0.5 0.166667 0 0.533333 0.166667 0 + 0.566667 0.166667 0 0.6 0.166667 0 0.633333 0.166667 0 0.666667 0.166667 0 + 0.7 0.166667 0 0.733333 0.166667 0 0.766667 0.166667 0 0.8 0.166667 0 + 0.833333 0.166667 0 0.866667 0.166667 0 0.9 0.166667 0 0.933333 0.166667 0 + 0.966667 0.166667 0 1 0.166667 0 0 0.2 0 0.0333333 0.2 0 + 0.0666667 0.2 0 0.1 0.2 0 0.133333 0.2 0 0.166667 0.2 0 + 0.2 0.2 0 0.233333 0.2 0 0.266667 0.2 0 0.3 0.2 0 + 0.333333 0.2 0 0.366667 0.2 0 0.4 0.2 0 0.433333 0.2 0 + 0.466667 0.2 0 0.5 0.2 0 0.533333 0.2 0 0.566667 0.2 0 + 0.6 0.2 0 0.633333 0.2 0 0.666667 0.2 0 0.7 0.2 0 + 0.733333 0.2 0 0.766667 0.2 0 0.8 0.2 0 0.833333 0.2 0 + 0.866667 0.2 0 0.9 0.2 0 0.933333 0.2 0 0.966667 0.2 0 + 1 0.2 0 0 0.233333 0 0.0333333 0.233333 0 0.0666667 0.233333 0 + 0.1 0.233333 0 0.133333 0.233333 0 0.166667 0.233333 0 0.2 0.233333 0 + 0.233333 0.233333 0 0.266667 0.233333 0 0.3 0.233333 0 0.333333 0.233333 0 + 0.366667 0.233333 0 0.4 0.233333 0 0.433333 0.233333 0 0.466667 0.233333 0 + 0.5 0.233333 0 0.533333 0.233333 0 0.566667 0.233333 0 0.6 0.233333 0 + 0.633333 0.233333 0 0.666667 0.233333 0 0.7 0.233333 0 0.733333 0.233333 0 + 0.766667 0.233333 0 0.8 0.233333 0 0.833333 0.233333 0 0.866667 0.233333 0 + 0.9 0.233333 0 0.933333 0.233333 0 0.966667 0.233333 0 1 0.233333 0 + 0 0.266667 0 0.0333333 0.266667 0 0.0666667 0.266667 0 0.1 0.266667 0 + 0.133333 0.266667 0 0.166667 0.266667 0 0.2 0.266667 0 0.233333 0.266667 0 + 0.266667 0.266667 0 0.3 0.266667 0 0.333333 0.266667 0 0.366667 0.266667 0 + 0.4 0.266667 0 0.433333 0.266667 0 0.466667 0.266667 0 0.5 0.266667 0 + 0.533333 0.266667 0 0.566667 0.266667 0 0.6 0.266667 0 0.633333 0.266667 0 + 0.666667 0.266667 0 0.7 0.266667 0 0.733333 0.266667 0 0.766667 0.266667 0 + 0.8 0.266667 0 0.833333 0.266667 0 0.866667 0.266667 0 0.9 0.266667 0 + 0.933333 0.266667 0 0.966667 0.266667 0 1 0.266667 0 0 0.3 0 + 0.0333333 0.3 0 0.0666667 0.3 0 0.1 0.3 0 0.133333 0.3 0 + 0.166667 0.3 0 0.2 0.3 0 0.233333 0.3 0 0.266667 0.3 0 + 0.3 0.3 0 0.333333 0.3 0 0.366667 0.3 0 0.4 0.3 0 + 0.433333 0.3 0 0.466667 0.3 0 0.5 0.3 0 0.533333 0.3 0 + 0.566667 0.3 0 0.6 0.3 0 0.633333 0.3 0 0.666667 0.3 0 + 0.7 0.3 0 0.733333 0.3 0 0.766667 0.3 0 0.8 0.3 0 + 0.833333 0.3 0 0.866667 0.3 0 0.9 0.3 0 0.933333 0.3 0 + 0.966667 0.3 0 1 0.3 0 0 0.333333 0 0.0333333 0.333333 0 + 0.0666667 0.333333 0 0.1 0.333333 0 0.133333 0.333333 0 0.166667 0.333333 0 + 0.2 0.333333 0 0.233333 0.333333 0 0.266667 0.333333 0 0.3 0.333333 0 + 0.333333 0.333333 0 0.366667 0.333333 0 0.4 0.333333 0 0.433333 0.333333 0 + 0.466667 0.333333 0 0.5 0.333333 0 0.533333 0.333333 0 0.566667 0.333333 0 + 0.6 0.333333 0 0.633333 0.333333 0 0.666667 0.333333 0 0.7 0.333333 0 + 0.733333 0.333333 0 0.766667 0.333333 0 0.8 0.333333 0 0.833333 0.333333 0 + 0.866667 0.333333 0 0.9 0.333333 0 0.933333 0.333333 0 0.966667 0.333333 0 + 1 0.333333 0 0 0.366667 0 0.0333333 0.366667 0 0.0666667 0.366667 0 + 0.1 0.366667 0 0.133333 0.366667 0 0.166667 0.366667 0 0.2 0.366667 0 + 0.233333 0.366667 0 0.266667 0.366667 0 0.3 0.366667 0 0.333333 0.366667 0 + 0.366667 0.366667 0 0.4 0.366667 0 0.433333 0.366667 0 0.466667 0.366667 0 + 0.5 0.366667 0 0.533333 0.366667 0 0.566667 0.366667 0 0.6 0.366667 0 + 0.633333 0.366667 0 0.666667 0.366667 0 0.7 0.366667 0 0.733333 0.366667 0 + 0.766667 0.366667 0 0.8 0.366667 0 0.833333 0.366667 0 0.866667 0.366667 0 + 0.9 0.366667 0 0.933333 0.366667 0 0.966667 0.366667 0 1 0.366667 0 + 0 0.4 0 0.0333333 0.4 0 0.0666667 0.4 0 0.1 0.4 0 + 0.133333 0.4 0 0.166667 0.4 0 0.2 0.4 0 0.233333 0.4 0 + 0.266667 0.4 0 0.3 0.4 0 0.333333 0.4 0 0.366667 0.4 0 + 0.4 0.4 0 0.433333 0.4 0 0.466667 0.4 0 0.5 0.4 0 + 0.533333 0.4 0 0.566667 0.4 0 0.6 0.4 0 0.633333 0.4 0 + 0.666667 0.4 0 0.7 0.4 0 0.733333 0.4 0 0.766667 0.4 0 + 0.8 0.4 0 0.833333 0.4 0 0.866667 0.4 0 0.9 0.4 0 + 0.933333 0.4 0 0.966667 0.4 0 1 0.4 0 0 0.433333 0 + 0.0333333 0.433333 0 0.0666667 0.433333 0 0.1 0.433333 0 0.133333 0.433333 0 + 0.166667 0.433333 0 0.2 0.433333 0 0.233333 0.433333 0 0.266667 0.433333 0 + 0.3 0.433333 0 0.333333 0.433333 0 0.366667 0.433333 0 0.4 0.433333 0 + 0.433333 0.433333 0 0.466667 0.433333 0 0.5 0.433333 0 0.533333 0.433333 0 + 0.566667 0.433333 0 0.6 0.433333 0 0.633333 0.433333 0 0.666667 0.433333 0 + 0.7 0.433333 0 0.733333 0.433333 0 0.766667 0.433333 0 0.8 0.433333 0 + 0.833333 0.433333 0 0.866667 0.433333 0 0.9 0.433333 0 0.933333 0.433333 0 + 0.966667 0.433333 0 1 0.433333 0 0 0.466667 0 0.0333333 0.466667 0 + 0.0666667 0.466667 0 0.1 0.466667 0 0.133333 0.466667 0 0.166667 0.466667 0 + 0.2 0.466667 0 0.233333 0.466667 0 0.266667 0.466667 0 0.3 0.466667 0 + 0.333333 0.466667 0 0.366667 0.466667 0 0.4 0.466667 0 0.433333 0.466667 0 + 0.466667 0.466667 0 0.5 0.466667 0 0.533333 0.466667 0 0.566667 0.466667 0 + 0.6 0.466667 0 0.633333 0.466667 0 0.666667 0.466667 0 0.7 0.466667 0 + 0.733333 0.466667 0 0.766667 0.466667 0 0.8 0.466667 0 0.833333 0.466667 0 + 0.866667 0.466667 0 0.9 0.466667 0 0.933333 0.466667 0 0.966667 0.466667 0 + 1 0.466667 0 0 0.5 0 0.0333333 0.5 0 0.0666667 0.5 0 + 0.1 0.5 0 0.133333 0.5 0 0.166667 0.5 0 0.2 0.5 0 + 0.233333 0.5 0 0.266667 0.5 0 0.3 0.5 0 0.333333 0.5 0 + 0.366667 0.5 0 0.4 0.5 0 0.433333 0.5 0 0.466667 0.5 0 + 0.5 0.5 0 0.533333 0.5 0 0.566667 0.5 0 0.6 0.5 0 + 0.633333 0.5 0 0.666667 0.5 0 0.7 0.5 0 0.733333 0.5 0 + 0.766667 0.5 0 0.8 0.5 0 0.833333 0.5 0 0.866667 0.5 0 + 0.9 0.5 0 0.933333 0.5 0 0.966667 0.5 0 1 0.5 0 + 0 0.533333 0 0.0333333 0.533333 0 0.0666667 0.533333 0 0.1 0.533333 0 + 0.133333 0.533333 0 0.166667 0.533333 0 0.2 0.533333 0 0.233333 0.533333 0 + 0.266667 0.533333 0 0.3 0.533333 0 0.333333 0.533333 0 0.366667 0.533333 0 + 0.4 0.533333 0 0.433333 0.533333 0 0.466667 0.533333 0 0.5 0.533333 0 + 0.533333 0.533333 0 0.566667 0.533333 0 0.6 0.533333 0 0.633333 0.533333 0 + 0.666667 0.533333 0 0.7 0.533333 0 0.733333 0.533333 0 0.766667 0.533333 0 + 0.8 0.533333 0 0.833333 0.533333 0 0.866667 0.533333 0 0.9 0.533333 0 + 0.933333 0.533333 0 0.966667 0.533333 0 1 0.533333 0 0 0.566667 0 + 0.0333333 0.566667 0 0.0666667 0.566667 0 0.1 0.566667 0 0.133333 0.566667 0 + 0.166667 0.566667 0 0.2 0.566667 0 0.233333 0.566667 0 0.266667 0.566667 0 + 0.3 0.566667 0 0.333333 0.566667 0 0.366667 0.566667 0 0.4 0.566667 0 + 0.433333 0.566667 0 0.466667 0.566667 0 0.5 0.566667 0 0.533333 0.566667 0 + 0.566667 0.566667 0 0.6 0.566667 0 0.633333 0.566667 0 0.666667 0.566667 0 + 0.7 0.566667 0 0.733333 0.566667 0 0.766667 0.566667 0 0.8 0.566667 0 + 0.833333 0.566667 0 0.866667 0.566667 0 0.9 0.566667 0 0.933333 0.566667 0 + 0.966667 0.566667 0 1 0.566667 0 0 0.6 0 0.0333333 0.6 0 + 0.0666667 0.6 0 0.1 0.6 0 0.133333 0.6 0 0.166667 0.6 0 + 0.2 0.6 0 0.233333 0.6 0 0.266667 0.6 0 0.3 0.6 0 + 0.333333 0.6 0 0.366667 0.6 0 0.4 0.6 0 0.433333 0.6 0 + 0.466667 0.6 0 0.5 0.6 0 0.533333 0.6 0 0.566667 0.6 0 + 0.6 0.6 0 0.633333 0.6 0 0.666667 0.6 0 0.7 0.6 0 + 0.733333 0.6 0 0.766667 0.6 0 0.8 0.6 0 0.833333 0.6 0 + 0.866667 0.6 0 0.9 0.6 0 0.933333 0.6 0 0.966667 0.6 0 + 1 0.6 0 0 0.633333 0 0.0333333 0.633333 0 0.0666667 0.633333 0 + 0.1 0.633333 0 0.133333 0.633333 0 0.166667 0.633333 0 0.2 0.633333 0 + 0.233333 0.633333 0 0.266667 0.633333 0 0.3 0.633333 0 0.333333 0.633333 0 + 0.366667 0.633333 0 0.4 0.633333 0 0.433333 0.633333 0 0.466667 0.633333 0 + 0.5 0.633333 0 0.533333 0.633333 0 0.566667 0.633333 0 0.6 0.633333 0 + 0.633333 0.633333 0 0.666667 0.633333 0 0.7 0.633333 0 0.733333 0.633333 0 + 0.766667 0.633333 0 0.8 0.633333 0 0.833333 0.633333 0 0.866667 0.633333 0 + 0.9 0.633333 0 0.933333 0.633333 0 0.966667 0.633333 0 1 0.633333 0 + 0 0.666667 0 0.0333333 0.666667 0 0.0666667 0.666667 0 0.1 0.666667 0 + 0.133333 0.666667 0 0.166667 0.666667 0 0.2 0.666667 0 0.233333 0.666667 0 + 0.266667 0.666667 0 0.3 0.666667 0 0.333333 0.666667 0 0.366667 0.666667 0 + 0.4 0.666667 0 0.433333 0.666667 0 0.466667 0.666667 0 0.5 0.666667 0 + 0.533333 0.666667 0 0.566667 0.666667 0 0.6 0.666667 0 0.633333 0.666667 0 + 0.666667 0.666667 0 0.7 0.666667 0 0.733333 0.666667 0 0.766667 0.666667 0 + 0.8 0.666667 0 0.833333 0.666667 0 0.866667 0.666667 0 0.9 0.666667 0 + 0.933333 0.666667 0 0.966667 0.666667 0 1 0.666667 0 0 0.7 0 + 0.0333333 0.7 0 0.0666667 0.7 0 0.1 0.7 0 0.133333 0.7 0 + 0.166667 0.7 0 0.2 0.7 0 0.233333 0.7 0 0.266667 0.7 0 + 0.3 0.7 0 0.333333 0.7 0 0.366667 0.7 0 0.4 0.7 0 + 0.433333 0.7 0 0.466667 0.7 0 0.5 0.7 0 0.533333 0.7 0 + 0.566667 0.7 0 0.6 0.7 0 0.633333 0.7 0 0.666667 0.7 0 + 0.7 0.7 0 0.733333 0.7 0 0.766667 0.7 0 0.8 0.7 0 + 0.833333 0.7 0 0.866667 0.7 0 0.9 0.7 0 0.933333 0.7 0 + 0.966667 0.7 0 1 0.7 0 0 0.733333 0 0.0333333 0.733333 0 + 0.0666667 0.733333 0 0.1 0.733333 0 0.133333 0.733333 0 0.166667 0.733333 0 + 0.2 0.733333 0 0.233333 0.733333 0 0.266667 0.733333 0 0.3 0.733333 0 + 0.333333 0.733333 0 0.366667 0.733333 0 0.4 0.733333 0 0.433333 0.733333 0 + 0.466667 0.733333 0 0.5 0.733333 0 0.533333 0.733333 0 0.566667 0.733333 0 + 0.6 0.733333 0 0.633333 0.733333 0 0.666667 0.733333 0 0.7 0.733333 0 + 0.733333 0.733333 0 0.766667 0.733333 0 0.8 0.733333 0 0.833333 0.733333 0 + 0.866667 0.733333 0 0.9 0.733333 0 0.933333 0.733333 0 0.966667 0.733333 0 + 1 0.733333 0 0 0.766667 0 0.0333333 0.766667 0 0.0666667 0.766667 0 + 0.1 0.766667 0 0.133333 0.766667 0 0.166667 0.766667 0 0.2 0.766667 0 + 0.233333 0.766667 0 0.266667 0.766667 0 0.3 0.766667 0 0.333333 0.766667 0 + 0.366667 0.766667 0 0.4 0.766667 0 0.433333 0.766667 0 0.466667 0.766667 0 + 0.5 0.766667 0 0.533333 0.766667 0 0.566667 0.766667 0 0.6 0.766667 0 + 0.633333 0.766667 0 0.666667 0.766667 0 0.7 0.766667 0 0.733333 0.766667 0 + 0.766667 0.766667 0 0.8 0.766667 0 0.833333 0.766667 0 0.866667 0.766667 0 + 0.9 0.766667 0 0.933333 0.766667 0 0.966667 0.766667 0 1 0.766667 0 + 0 0.8 0 0.0333333 0.8 0 0.0666667 0.8 0 0.1 0.8 0 + 0.133333 0.8 0 0.166667 0.8 0 0.2 0.8 0 0.233333 0.8 0 + 0.266667 0.8 0 0.3 0.8 0 0.333333 0.8 0 0.366667 0.8 0 + 0.4 0.8 0 0.433333 0.8 0 0.466667 0.8 0 0.5 0.8 0 + 0.533333 0.8 0 0.566667 0.8 0 0.6 0.8 0 0.633333 0.8 0 + 0.666667 0.8 0 0.7 0.8 0 0.733333 0.8 0 0.766667 0.8 0 + 0.8 0.8 0 0.833333 0.8 0 0.866667 0.8 0 0.9 0.8 0 + 0.933333 0.8 0 0.966667 0.8 0 1 0.8 0 0 0.833333 0 + 0.0333333 0.833333 0 0.0666667 0.833333 0 0.1 0.833333 0 0.133333 0.833333 0 + 0.166667 0.833333 0 0.2 0.833333 0 0.233333 0.833333 0 0.266667 0.833333 0 + 0.3 0.833333 0 0.333333 0.833333 0 0.366667 0.833333 0 0.4 0.833333 0 + 0.433333 0.833333 0 0.466667 0.833333 0 0.5 0.833333 0 0.533333 0.833333 0 + 0.566667 0.833333 0 0.6 0.833333 0 0.633333 0.833333 0 0.666667 0.833333 0 + 0.7 0.833333 0 0.733333 0.833333 0 0.766667 0.833333 0 0.8 0.833333 0 + 0.833333 0.833333 0 0.866667 0.833333 0 0.9 0.833333 0 0.933333 0.833333 0 + 0.966667 0.833333 0 1 0.833333 0 0 0.866667 0 0.0333333 0.866667 0 + 0.0666667 0.866667 0 0.1 0.866667 0 0.133333 0.866667 0 0.166667 0.866667 0 + 0.2 0.866667 0 0.233333 0.866667 0 0.266667 0.866667 0 0.3 0.866667 0 + 0.333333 0.866667 0 0.366667 0.866667 0 0.4 0.866667 0 0.433333 0.866667 0 + 0.466667 0.866667 0 0.5 0.866667 0 0.533333 0.866667 0 0.566667 0.866667 0 + 0.6 0.866667 0 0.633333 0.866667 0 0.666667 0.866667 0 0.7 0.866667 0 + 0.733333 0.866667 0 0.766667 0.866667 0 0.8 0.866667 0 0.833333 0.866667 0 + 0.866667 0.866667 0 0.9 0.866667 0 0.933333 0.866667 0 0.966667 0.866667 0 + 1 0.866667 0 0 0.9 0 0.0333333 0.9 0 0.0666667 0.9 0 + 0.1 0.9 0 0.133333 0.9 0 0.166667 0.9 0 0.2 0.9 0 + 0.233333 0.9 0 0.266667 0.9 0 0.3 0.9 0 0.333333 0.9 0 + 0.366667 0.9 0 0.4 0.9 0 0.433333 0.9 0 0.466667 0.9 0 + 0.5 0.9 0 0.533333 0.9 0 0.566667 0.9 0 0.6 0.9 0 + 0.633333 0.9 0 0.666667 0.9 0 0.7 0.9 0 0.733333 0.9 0 + 0.766667 0.9 0 0.8 0.9 0 0.833333 0.9 0 0.866667 0.9 0 + 0.9 0.9 0 0.933333 0.9 0 0.966667 0.9 0 1 0.9 0 + 0 0.933333 0 0.0333333 0.933333 0 0.0666667 0.933333 0 0.1 0.933333 0 + 0.133333 0.933333 0 0.166667 0.933333 0 0.2 0.933333 0 0.233333 0.933333 0 + 0.266667 0.933333 0 0.3 0.933333 0 0.333333 0.933333 0 0.366667 0.933333 0 + 0.4 0.933333 0 0.433333 0.933333 0 0.466667 0.933333 0 0.5 0.933333 0 + 0.533333 0.933333 0 0.566667 0.933333 0 0.6 0.933333 0 0.633333 0.933333 0 + 0.666667 0.933333 0 0.7 0.933333 0 0.733333 0.933333 0 0.766667 0.933333 0 + 0.8 0.933333 0 0.833333 0.933333 0 0.866667 0.933333 0 0.9 0.933333 0 + 0.933333 0.933333 0 0.966667 0.933333 0 1 0.933333 0 0 0.966667 0 + 0.0333333 0.966667 0 0.0666667 0.966667 0 0.1 0.966667 0 0.133333 0.966667 0 + 0.166667 0.966667 0 0.2 0.966667 0 0.233333 0.966667 0 0.266667 0.966667 0 + 0.3 0.966667 0 0.333333 0.966667 0 0.366667 0.966667 0 0.4 0.966667 0 + 0.433333 0.966667 0 0.466667 0.966667 0 0.5 0.966667 0 0.533333 0.966667 0 + 0.566667 0.966667 0 0.6 0.966667 0 0.633333 0.966667 0 0.666667 0.966667 0 + 0.7 0.966667 0 0.733333 0.966667 0 0.766667 0.966667 0 0.8 0.966667 0 + 0.833333 0.966667 0 0.866667 0.966667 0 0.9 0.966667 0 0.933333 0.966667 0 + 0.966667 0.966667 0 1 0.966667 0 0 1 0 0.0333333 1 0 + 0.0666667 1 0 0.1 1 0 0.133333 1 0 0.166667 1 0 + 0.2 1 0 0.233333 1 0 0.266667 1 0 0.3 1 0 + 0.333333 1 0 0.366667 1 0 0.4 1 0 0.433333 1 0 + 0.466667 1 0 0.5 1 0 0.533333 1 0 0.566667 1 0 + 0.6 1 0 0.633333 1 0 0.666667 1 0 0.7 1 0 + 0.733333 1 0 0.766667 1 0 0.8 1 0 0.833333 1 0 + 0.866667 1 0 0.9 1 0 0.933333 1 0 0.966667 1 0 + 1 1 0 + + + + + 0 1 3 2 1 4 5 3 4 6 7 5 + 6 8 9 7 8 10 11 9 10 12 13 11 + 12 14 15 13 14 16 17 15 16 18 19 17 + 18 20 21 19 20 22 23 21 22 24 25 23 + 24 26 27 25 26 28 29 27 28 30 31 29 + 30 32 33 31 32 34 35 33 34 36 37 35 + 36 38 39 37 38 40 41 39 40 42 43 41 + 42 44 45 43 44 46 47 45 46 48 49 47 + 48 50 51 49 50 52 53 51 52 54 55 53 + 54 56 57 55 56 58 59 57 58 60 61 59 + 2 3 63 62 3 5 64 63 5 7 65 64 + 7 9 66 65 9 11 67 66 11 13 68 67 + 13 15 69 68 15 17 70 69 17 19 71 70 + 19 21 72 71 21 23 73 72 23 25 74 73 + 25 27 75 74 27 29 76 75 29 31 77 76 + 31 33 78 77 33 35 79 78 35 37 80 79 + 37 39 81 80 39 41 82 81 41 43 83 82 + 43 45 84 83 45 47 85 84 47 49 86 85 + 49 51 87 86 51 53 88 87 53 55 89 88 + 55 57 90 89 57 59 91 90 59 61 92 91 + 62 63 94 93 63 64 95 94 64 65 96 95 + 65 66 97 96 66 67 98 97 67 68 99 98 + 68 69 100 99 69 70 101 100 70 71 102 101 + 71 72 103 102 72 73 104 103 73 74 105 104 + 74 75 106 105 75 76 107 106 76 77 108 107 + 77 78 109 108 78 79 110 109 79 80 111 110 + 80 81 112 111 81 82 113 112 82 83 114 113 + 83 84 115 114 84 85 116 115 85 86 117 116 + 86 87 118 117 87 88 119 118 88 89 120 119 + 89 90 121 120 90 91 122 121 91 92 123 122 + 93 94 125 124 94 95 126 125 95 96 127 126 + 96 97 128 127 97 98 129 128 98 99 130 129 + 99 100 131 130 100 101 132 131 101 102 133 132 + 102 103 134 133 103 104 135 134 104 105 136 135 + 105 106 137 136 106 107 138 137 107 108 139 138 + 108 109 140 139 109 110 141 140 110 111 142 141 + 111 112 143 142 112 113 144 143 113 114 145 144 + 114 115 146 145 115 116 147 146 116 117 148 147 + 117 118 149 148 118 119 150 149 119 120 151 150 + 120 121 152 151 121 122 153 152 122 123 154 153 + 124 125 156 155 125 126 157 156 126 127 158 157 + 127 128 159 158 128 129 160 159 129 130 161 160 + 130 131 162 161 131 132 163 162 132 133 164 163 + 133 134 165 164 134 135 166 165 135 136 167 166 + 136 137 168 167 137 138 169 168 138 139 170 169 + 139 140 171 170 140 141 172 171 141 142 173 172 + 142 143 174 173 143 144 175 174 144 145 176 175 + 145 146 177 176 146 147 178 177 147 148 179 178 + 148 149 180 179 149 150 181 180 150 151 182 181 + 151 152 183 182 152 153 184 183 153 154 185 184 + 155 156 187 186 156 157 188 187 157 158 189 188 + 158 159 190 189 159 160 191 190 160 161 192 191 + 161 162 193 192 162 163 194 193 163 164 195 194 + 164 165 196 195 165 166 197 196 166 167 198 197 + 167 168 199 198 168 169 200 199 169 170 201 200 + 170 171 202 201 171 172 203 202 172 173 204 203 + 173 174 205 204 174 175 206 205 175 176 207 206 + 176 177 208 207 177 178 209 208 178 179 210 209 + 179 180 211 210 180 181 212 211 181 182 213 212 + 182 183 214 213 183 184 215 214 184 185 216 215 + 186 187 218 217 187 188 219 218 188 189 220 219 + 189 190 221 220 190 191 222 221 191 192 223 222 + 192 193 224 223 193 194 225 224 194 195 226 225 + 195 196 227 226 196 197 228 227 197 198 229 228 + 198 199 230 229 199 200 231 230 200 201 232 231 + 201 202 233 232 202 203 234 233 203 204 235 234 + 204 205 236 235 205 206 237 236 206 207 238 237 + 207 208 239 238 208 209 240 239 209 210 241 240 + 210 211 242 241 211 212 243 242 212 213 244 243 + 213 214 245 244 214 215 246 245 215 216 247 246 + 217 218 249 248 218 219 250 249 219 220 251 250 + 220 221 252 251 221 222 253 252 222 223 254 253 + 223 224 255 254 224 225 256 255 225 226 257 256 + 226 227 258 257 227 228 259 258 228 229 260 259 + 229 230 261 260 230 231 262 261 231 232 263 262 + 232 233 264 263 233 234 265 264 234 235 266 265 + 235 236 267 266 236 237 268 267 237 238 269 268 + 238 239 270 269 239 240 271 270 240 241 272 271 + 241 242 273 272 242 243 274 273 243 244 275 274 + 244 245 276 275 245 246 277 276 246 247 278 277 + 248 249 280 279 249 250 281 280 250 251 282 281 + 251 252 283 282 252 253 284 283 253 254 285 284 + 254 255 286 285 255 256 287 286 256 257 288 287 + 257 258 289 288 258 259 290 289 259 260 291 290 + 260 261 292 291 261 262 293 292 262 263 294 293 + 263 264 295 294 264 265 296 295 265 266 297 296 + 266 267 298 297 267 268 299 298 268 269 300 299 + 269 270 301 300 270 271 302 301 271 272 303 302 + 272 273 304 303 273 274 305 304 274 275 306 305 + 275 276 307 306 276 277 308 307 277 278 309 308 + 279 280 311 310 280 281 312 311 281 282 313 312 + 282 283 314 313 283 284 315 314 284 285 316 315 + 285 286 317 316 286 287 318 317 287 288 319 318 + 288 289 320 319 289 290 321 320 290 291 322 321 + 291 292 323 322 292 293 324 323 293 294 325 324 + 294 295 326 325 295 296 327 326 296 297 328 327 + 297 298 329 328 298 299 330 329 299 300 331 330 + 300 301 332 331 301 302 333 332 302 303 334 333 + 303 304 335 334 304 305 336 335 305 306 337 336 + 306 307 338 337 307 308 339 338 308 309 340 339 + 310 311 342 341 311 312 343 342 312 313 344 343 + 313 314 345 344 314 315 346 345 315 316 347 346 + 316 317 348 347 317 318 349 348 318 319 350 349 + 319 320 351 350 320 321 352 351 321 322 353 352 + 322 323 354 353 323 324 355 354 324 325 356 355 + 325 326 357 356 326 327 358 357 327 328 359 358 + 328 329 360 359 329 330 361 360 330 331 362 361 + 331 332 363 362 332 333 364 363 333 334 365 364 + 334 335 366 365 335 336 367 366 336 337 368 367 + 337 338 369 368 338 339 370 369 339 340 371 370 + 341 342 373 372 342 343 374 373 343 344 375 374 + 344 345 376 375 345 346 377 376 346 347 378 377 + 347 348 379 378 348 349 380 379 349 350 381 380 + 350 351 382 381 351 352 383 382 352 353 384 383 + 353 354 385 384 354 355 386 385 355 356 387 386 + 356 357 388 387 357 358 389 388 358 359 390 389 + 359 360 391 390 360 361 392 391 361 362 393 392 + 362 363 394 393 363 364 395 394 364 365 396 395 + 365 366 397 396 366 367 398 397 367 368 399 398 + 368 369 400 399 369 370 401 400 370 371 402 401 + 372 373 404 403 373 374 405 404 374 375 406 405 + 375 376 407 406 376 377 408 407 377 378 409 408 + 378 379 410 409 379 380 411 410 380 381 412 411 + 381 382 413 412 382 383 414 413 383 384 415 414 + 384 385 416 415 385 386 417 416 386 387 418 417 + 387 388 419 418 388 389 420 419 389 390 421 420 + 390 391 422 421 391 392 423 422 392 393 424 423 + 393 394 425 424 394 395 426 425 395 396 427 426 + 396 397 428 427 397 398 429 428 398 399 430 429 + 399 400 431 430 400 401 432 431 401 402 433 432 + 403 404 435 434 404 405 436 435 405 406 437 436 + 406 407 438 437 407 408 439 438 408 409 440 439 + 409 410 441 440 410 411 442 441 411 412 443 442 + 412 413 444 443 413 414 445 444 414 415 446 445 + 415 416 447 446 416 417 448 447 417 418 449 448 + 418 419 450 449 419 420 451 450 420 421 452 451 + 421 422 453 452 422 423 454 453 423 424 455 454 + 424 425 456 455 425 426 457 456 426 427 458 457 + 427 428 459 458 428 429 460 459 429 430 461 460 + 430 431 462 461 431 432 463 462 432 433 464 463 + 434 435 466 465 435 436 467 466 436 437 468 467 + 437 438 469 468 438 439 470 469 439 440 471 470 + 440 441 472 471 441 442 473 472 442 443 474 473 + 443 444 475 474 444 445 476 475 445 446 477 476 + 446 447 478 477 447 448 479 478 448 449 480 479 + 449 450 481 480 450 451 482 481 451 452 483 482 + 452 453 484 483 453 454 485 484 454 455 486 485 + 455 456 487 486 456 457 488 487 457 458 489 488 + 458 459 490 489 459 460 491 490 460 461 492 491 + 461 462 493 492 462 463 494 493 463 464 495 494 + 465 466 497 496 466 467 498 497 467 468 499 498 + 468 469 500 499 469 470 501 500 470 471 502 501 + 471 472 503 502 472 473 504 503 473 474 505 504 + 474 475 506 505 475 476 507 506 476 477 508 507 + 477 478 509 508 478 479 510 509 479 480 511 510 + 480 481 512 511 481 482 513 512 482 483 514 513 + 483 484 515 514 484 485 516 515 485 486 517 516 + 486 487 518 517 487 488 519 518 488 489 520 519 + 489 490 521 520 490 491 522 521 491 492 523 522 + 492 493 524 523 493 494 525 524 494 495 526 525 + 496 497 528 527 497 498 529 528 498 499 530 529 + 499 500 531 530 500 501 532 531 501 502 533 532 + 502 503 534 533 503 504 535 534 504 505 536 535 + 505 506 537 536 506 507 538 537 507 508 539 538 + 508 509 540 539 509 510 541 540 510 511 542 541 + 511 512 543 542 512 513 544 543 513 514 545 544 + 514 515 546 545 515 516 547 546 516 517 548 547 + 517 518 549 548 518 519 550 549 519 520 551 550 + 520 521 552 551 521 522 553 552 522 523 554 553 + 523 524 555 554 524 525 556 555 525 526 557 556 + 527 528 559 558 528 529 560 559 529 530 561 560 + 530 531 562 561 531 532 563 562 532 533 564 563 + 533 534 565 564 534 535 566 565 535 536 567 566 + 536 537 568 567 537 538 569 568 538 539 570 569 + 539 540 571 570 540 541 572 571 541 542 573 572 + 542 543 574 573 543 544 575 574 544 545 576 575 + 545 546 577 576 546 547 578 577 547 548 579 578 + 548 549 580 579 549 550 581 580 550 551 582 581 + 551 552 583 582 552 553 584 583 553 554 585 584 + 554 555 586 585 555 556 587 586 556 557 588 587 + 558 559 590 589 559 560 591 590 560 561 592 591 + 561 562 593 592 562 563 594 593 563 564 595 594 + 564 565 596 595 565 566 597 596 566 567 598 597 + 567 568 599 598 568 569 600 599 569 570 601 600 + 570 571 602 601 571 572 603 602 572 573 604 603 + 573 574 605 604 574 575 606 605 575 576 607 606 + 576 577 608 607 577 578 609 608 578 579 610 609 + 579 580 611 610 580 581 612 611 581 582 613 612 + 582 583 614 613 583 584 615 614 584 585 616 615 + 585 586 617 616 586 587 618 617 587 588 619 618 + 589 590 621 620 590 591 622 621 591 592 623 622 + 592 593 624 623 593 594 625 624 594 595 626 625 + 595 596 627 626 596 597 628 627 597 598 629 628 + 598 599 630 629 599 600 631 630 600 601 632 631 + 601 602 633 632 602 603 634 633 603 604 635 634 + 604 605 636 635 605 606 637 636 606 607 638 637 + 607 608 639 638 608 609 640 639 609 610 641 640 + 610 611 642 641 611 612 643 642 612 613 644 643 + 613 614 645 644 614 615 646 645 615 616 647 646 + 616 617 648 647 617 618 649 648 618 619 650 649 + 620 621 652 651 621 622 653 652 622 623 654 653 + 623 624 655 654 624 625 656 655 625 626 657 656 + 626 627 658 657 627 628 659 658 628 629 660 659 + 629 630 661 660 630 631 662 661 631 632 663 662 + 632 633 664 663 633 634 665 664 634 635 666 665 + 635 636 667 666 636 637 668 667 637 638 669 668 + 638 639 670 669 639 640 671 670 640 641 672 671 + 641 642 673 672 642 643 674 673 643 644 675 674 + 644 645 676 675 645 646 677 676 646 647 678 677 + 647 648 679 678 648 649 680 679 649 650 681 680 + 651 652 683 682 652 653 684 683 653 654 685 684 + 654 655 686 685 655 656 687 686 656 657 688 687 + 657 658 689 688 658 659 690 689 659 660 691 690 + 660 661 692 691 661 662 693 692 662 663 694 693 + 663 664 695 694 664 665 696 695 665 666 697 696 + 666 667 698 697 667 668 699 698 668 669 700 699 + 669 670 701 700 670 671 702 701 671 672 703 702 + 672 673 704 703 673 674 705 704 674 675 706 705 + 675 676 707 706 676 677 708 707 677 678 709 708 + 678 679 710 709 679 680 711 710 680 681 712 711 + 682 683 714 713 683 684 715 714 684 685 716 715 + 685 686 717 716 686 687 718 717 687 688 719 718 + 688 689 720 719 689 690 721 720 690 691 722 721 + 691 692 723 722 692 693 724 723 693 694 725 724 + 694 695 726 725 695 696 727 726 696 697 728 727 + 697 698 729 728 698 699 730 729 699 700 731 730 + 700 701 732 731 701 702 733 732 702 703 734 733 + 703 704 735 734 704 705 736 735 705 706 737 736 + 706 707 738 737 707 708 739 738 708 709 740 739 + 709 710 741 740 710 711 742 741 711 712 743 742 + 713 714 745 744 714 715 746 745 715 716 747 746 + 716 717 748 747 717 718 749 748 718 719 750 749 + 719 720 751 750 720 721 752 751 721 722 753 752 + 722 723 754 753 723 724 755 754 724 725 756 755 + 725 726 757 756 726 727 758 757 727 728 759 758 + 728 729 760 759 729 730 761 760 730 731 762 761 + 731 732 763 762 732 733 764 763 733 734 765 764 + 734 735 766 765 735 736 767 766 736 737 768 767 + 737 738 769 768 738 739 770 769 739 740 771 770 + 740 741 772 771 741 742 773 772 742 743 774 773 + 744 745 776 775 745 746 777 776 746 747 778 777 + 747 748 779 778 748 749 780 779 749 750 781 780 + 750 751 782 781 751 752 783 782 752 753 784 783 + 753 754 785 784 754 755 786 785 755 756 787 786 + 756 757 788 787 757 758 789 788 758 759 790 789 + 759 760 791 790 760 761 792 791 761 762 793 792 + 762 763 794 793 763 764 795 794 764 765 796 795 + 765 766 797 796 766 767 798 797 767 768 799 798 + 768 769 800 799 769 770 801 800 770 771 802 801 + 771 772 803 802 772 773 804 803 773 774 805 804 + 775 776 807 806 776 777 808 807 777 778 809 808 + 778 779 810 809 779 780 811 810 780 781 812 811 + 781 782 813 812 782 783 814 813 783 784 815 814 + 784 785 816 815 785 786 817 816 786 787 818 817 + 787 788 819 818 788 789 820 819 789 790 821 820 + 790 791 822 821 791 792 823 822 792 793 824 823 + 793 794 825 824 794 795 826 825 795 796 827 826 + 796 797 828 827 797 798 829 828 798 799 830 829 + 799 800 831 830 800 801 832 831 801 802 833 832 + 802 803 834 833 803 804 835 834 804 805 836 835 + 806 807 838 837 807 808 839 838 808 809 840 839 + 809 810 841 840 810 811 842 841 811 812 843 842 + 812 813 844 843 813 814 845 844 814 815 846 845 + 815 816 847 846 816 817 848 847 817 818 849 848 + 818 819 850 849 819 820 851 850 820 821 852 851 + 821 822 853 852 822 823 854 853 823 824 855 854 + 824 825 856 855 825 826 857 856 826 827 858 857 + 827 828 859 858 828 829 860 859 829 830 861 860 + 830 831 862 861 831 832 863 862 832 833 864 863 + 833 834 865 864 834 835 866 865 835 836 867 866 + 837 838 869 868 838 839 870 869 839 840 871 870 + 840 841 872 871 841 842 873 872 842 843 874 873 + 843 844 875 874 844 845 876 875 845 846 877 876 + 846 847 878 877 847 848 879 878 848 849 880 879 + 849 850 881 880 850 851 882 881 851 852 883 882 + 852 853 884 883 853 854 885 884 854 855 886 885 + 855 856 887 886 856 857 888 887 857 858 889 888 + 858 859 890 889 859 860 891 890 860 861 892 891 + 861 862 893 892 862 863 894 893 863 864 895 894 + 864 865 896 895 865 866 897 896 866 867 898 897 + 868 869 900 899 869 870 901 900 870 871 902 901 + 871 872 903 902 872 873 904 903 873 874 905 904 + 874 875 906 905 875 876 907 906 876 877 908 907 + 877 878 909 908 878 879 910 909 879 880 911 910 + 880 881 912 911 881 882 913 912 882 883 914 913 + 883 884 915 914 884 885 916 915 885 886 917 916 + 886 887 918 917 887 888 919 918 888 889 920 919 + 889 890 921 920 890 891 922 921 891 892 923 922 + 892 893 924 923 893 894 925 924 894 895 926 925 + 895 896 927 926 896 897 928 927 897 898 929 928 + 899 900 931 930 900 901 932 931 901 902 933 932 + 902 903 934 933 903 904 935 934 904 905 936 935 + 905 906 937 936 906 907 938 937 907 908 939 938 + 908 909 940 939 909 910 941 940 910 911 942 941 + 911 912 943 942 912 913 944 943 913 914 945 944 + 914 915 946 945 915 916 947 946 916 917 948 947 + 917 918 949 948 918 919 950 949 919 920 951 950 + 920 921 952 951 921 922 953 952 922 923 954 953 + 923 924 955 954 924 925 956 955 925 926 957 956 + 926 927 958 957 927 928 959 958 928 929 960 959 + + + 4 8 12 16 20 24 28 32 36 40 44 48 + 52 56 60 64 68 72 76 80 84 88 92 96 + 100 104 108 112 116 120 124 128 132 136 140 144 + 148 152 156 160 164 168 172 176 180 184 188 192 + 196 200 204 208 212 216 220 224 228 232 236 240 + 244 248 252 256 260 264 268 272 276 280 284 288 + 292 296 300 304 308 312 316 320 324 328 332 336 + 340 344 348 352 356 360 364 368 372 376 380 384 + 388 392 396 400 404 408 412 416 420 424 428 432 + 436 440 444 448 452 456 460 464 468 472 476 480 + 484 488 492 496 500 504 508 512 516 520 524 528 + 532 536 540 544 548 552 556 560 564 568 572 576 + 580 584 588 592 596 600 604 608 612 616 620 624 + 628 632 636 640 644 648 652 656 660 664 668 672 + 676 680 684 688 692 696 700 704 708 712 716 720 + 724 728 732 736 740 744 748 752 756 760 764 768 + 772 776 780 784 788 792 796 800 804 808 812 816 + 820 824 828 832 836 840 844 848 852 856 860 864 + 868 872 876 880 884 888 892 896 900 904 908 912 + 916 920 924 928 932 936 940 944 948 952 956 960 + 964 968 972 976 980 984 988 992 996 1000 1004 1008 + 1012 1016 1020 1024 1028 1032 1036 1040 1044 1048 1052 1056 + 1060 1064 1068 1072 1076 1080 1084 1088 1092 1096 1100 1104 + 1108 1112 1116 1120 1124 1128 1132 1136 1140 1144 1148 1152 + 1156 1160 1164 1168 1172 1176 1180 1184 1188 1192 1196 1200 + 1204 1208 1212 1216 1220 1224 1228 1232 1236 1240 1244 1248 + 1252 1256 1260 1264 1268 1272 1276 1280 1284 1288 1292 1296 + 1300 1304 1308 1312 1316 1320 1324 1328 1332 1336 1340 1344 + 1348 1352 1356 1360 1364 1368 1372 1376 1380 1384 1388 1392 + 1396 1400 1404 1408 1412 1416 1420 1424 1428 1432 1436 1440 + 1444 1448 1452 1456 1460 1464 1468 1472 1476 1480 1484 1488 + 1492 1496 1500 1504 1508 1512 1516 1520 1524 1528 1532 1536 + 1540 1544 1548 1552 1556 1560 1564 1568 1572 1576 1580 1584 + 1588 1592 1596 1600 1604 1608 1612 1616 1620 1624 1628 1632 + 1636 1640 1644 1648 1652 1656 1660 1664 1668 1672 1676 1680 + 1684 1688 1692 1696 1700 1704 1708 1712 1716 1720 1724 1728 + 1732 1736 1740 1744 1748 1752 1756 1760 1764 1768 1772 1776 + 1780 1784 1788 1792 1796 1800 1804 1808 1812 1816 1820 1824 + 1828 1832 1836 1840 1844 1848 1852 1856 1860 1864 1868 1872 + 1876 1880 1884 1888 1892 1896 1900 1904 1908 1912 1916 1920 + 1924 1928 1932 1936 1940 1944 1948 1952 1956 1960 1964 1968 + 1972 1976 1980 1984 1988 1992 1996 2000 2004 2008 2012 2016 + 2020 2024 2028 2032 2036 2040 2044 2048 2052 2056 2060 2064 + 2068 2072 2076 2080 2084 2088 2092 2096 2100 2104 2108 2112 + 2116 2120 2124 2128 2132 2136 2140 2144 2148 2152 2156 2160 + 2164 2168 2172 2176 2180 2184 2188 2192 2196 2200 2204 2208 + 2212 2216 2220 2224 2228 2232 2236 2240 2244 2248 2252 2256 + 2260 2264 2268 2272 2276 2280 2284 2288 2292 2296 2300 2304 + 2308 2312 2316 2320 2324 2328 2332 2336 2340 2344 2348 2352 + 2356 2360 2364 2368 2372 2376 2380 2384 2388 2392 2396 2400 + 2404 2408 2412 2416 2420 2424 2428 2432 2436 2440 2444 2448 + 2452 2456 2460 2464 2468 2472 2476 2480 2484 2488 2492 2496 + 2500 2504 2508 2512 2516 2520 2524 2528 2532 2536 2540 2544 + 2548 2552 2556 2560 2564 2568 2572 2576 2580 2584 2588 2592 + 2596 2600 2604 2608 2612 2616 2620 2624 2628 2632 2636 2640 + 2644 2648 2652 2656 2660 2664 2668 2672 2676 2680 2684 2688 + 2692 2696 2700 2704 2708 2712 2716 2720 2724 2728 2732 2736 + 2740 2744 2748 2752 2756 2760 2764 2768 2772 2776 2780 2784 + 2788 2792 2796 2800 2804 2808 2812 2816 2820 2824 2828 2832 + 2836 2840 2844 2848 2852 2856 2860 2864 2868 2872 2876 2880 + 2884 2888 2892 2896 2900 2904 2908 2912 2916 2920 2924 2928 + 2932 2936 2940 2944 2948 2952 2956 2960 2964 2968 2972 2976 + 2980 2984 2988 2992 2996 3000 3004 3008 3012 3016 3020 3024 + 3028 3032 3036 3040 3044 3048 3052 3056 3060 3064 3068 3072 + 3076 3080 3084 3088 3092 3096 3100 3104 3108 3112 3116 3120 + 3124 3128 3132 3136 3140 3144 3148 3152 3156 3160 3164 3168 + 3172 3176 3180 3184 3188 3192 3196 3200 3204 3208 3212 3216 + 3220 3224 3228 3232 3236 3240 3244 3248 3252 3256 3260 3264 + 3268 3272 3276 3280 3284 3288 3292 3296 3300 3304 3308 3312 + 3316 3320 3324 3328 3332 3336 3340 3344 3348 3352 3356 3360 + 3364 3368 3372 3376 3380 3384 3388 3392 3396 3400 3404 3408 + 3412 3416 3420 3424 3428 3432 3436 3440 3444 3448 3452 3456 + 3460 3464 3468 3472 3476 3480 3484 3488 3492 3496 3500 3504 + 3508 3512 3516 3520 3524 3528 3532 3536 3540 3544 3548 3552 + 3556 3560 3564 3568 3572 3576 3580 3584 3588 3592 3596 3600 + + + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + + + + +